MercuryDPM
0.10
|
This class is used to extract statistical data from MD simulations. More...
#include <StatisticsPoint.h>
Public Member Functions | |
void | 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 (unsigned int argc, char *argv[]) | |
Advanced constructor that accepts arguments from the command line. More... | |
void | readStatArguments (unsigned int argc, char *argv[]) |
std::string | print () |
Outputs member variable values to a std::string. More... | |
void | set_statType () |
void | print_help () |
void | set_nx (int new_) |
void | set_hx (Mdouble hx) |
void | set_ny (int new_) |
void | set_hy (Mdouble hy) |
void | set_nz (int new_) |
void | set_hz (Mdouble hz) |
void | set_n (int n) |
void | set_h (Mdouble h) |
int | get_nx () |
int | get_ny () |
int | get_nz () |
void | set_tminStat (Mdouble t) |
void | set_tmaxStat (Mdouble t) |
void | set_tintStat (Mdouble t) |
Mdouble | get_tminStat () |
Mdouble | get_tmaxStat () |
Mdouble | get_tintStat () |
bool | check_current_time_for_statistics () |
void | set_CG_type (const char *new_) |
void | set_CG_type (CG new_) |
CG | get_CG_type () |
void | set_n (int nx_, int ny_, int nz_) |
void | get_n (int &nx_, int &ny_, int &nz_) |
void | set_w (Mdouble w) |
Set CG variables w2 and CG_invvolume. More... | |
void | set_w2 (Mdouble new_) |
Set CG variables w2 and CG_invvolume. More... | |
Mdouble | get_w () |
Mdouble | get_w2 () |
Mdouble | get_cutoff () |
Mdouble | get_cutoff2 () |
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 () |
this is a modified version of statistics_from_fstat_and_data. It is used to read p3d files More... | |
void | jump_p3c () |
get force statistics from particle collisions More... | |
void | set_doTimeAverage (bool new_) |
bool | get_doTimeAverage () |
void | set_StressTypeForFixedParticles (int new_) |
int | get_StressTypeForFixedParticles () |
void | set_infiniteStressForFixedParticles (bool new_) |
void | set_mirrorAtDomainBoundary (Mdouble new_) |
Mdouble | get_mirrorAtDomainBoundary () |
void | set_doVariance (bool new_) |
bool | get_doVariance () |
void | set_doGradient (bool new_) |
bool | get_doGradient () |
void | set_superexact (bool new_) |
bool | get_superexact () |
void | set_ignoreFixedParticles (bool new_) |
bool | get_ignoreFixedParticles () |
void | verbose () |
void | set_verbosity (int new_) |
int | get_verbosity () |
void | set_walls (bool new_) |
bool | get_walls () |
void | set_periodicWalls (bool new_) |
bool | get_periodicWalls () |
void | set_w_over_rmax (Mdouble new_) |
Mdouble | get_w_over_rmax () |
void | set_Positions () |
Set position of StatisticsPoint points and set variables to 0. More... | |
bool | read_next_from_data_file (unsigned int format) |
void | gather_force_statistics_from_fstat_and_data () |
get force statistics from particle collisions More... | |
void | gather_force_statistics_from_p3c (int version) |
get force statistics from particle collisions More... | |
void | gather_force_statistics_from_p3w (int version, std::vector< int > &index) |
get force statistics from particle collisions More... | |
void | evaluate_force_statistics (int wp=0) |
get force statistics More... | |
void | evaluate_wall_force_statistics (Vec3D P, int wp=0) |
get force statistics (i.e. first particle is a wall particle) More... | |
void | jump_fstat () |
void | initialize_statistics () |
Initializes statistics, i.e. setting w2, setting the grid and writing the header lines in the .stat file. More... | |
void | output_statistics () |
Calculates statistics for Particles (i.e. not collisions) More... | |
void | gather_statistics_collision (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 | process_statistics (bool usethese) |
Processes all gathered statistics and resets them afterwards. (Processing means either calculating time averages or writing out statistics) More... | |
void | finish_statistics () |
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 > > | get_Points () |
Mdouble | get_xminStat () |
Functions to acces and change the domain of statistics. More... | |
Mdouble | get_yminStat () |
Mdouble | get_zminStat () |
Mdouble | get_xmaxStat () |
Mdouble | get_ymaxStat () |
Mdouble | get_zmaxStat () |
void | set_xminStat (Mdouble xminStat_) |
void | set_yminStat (Mdouble yminStat_) |
void | set_zminStat (Mdouble zminStat_) |
void | set_xmaxStat (Mdouble xmaxStat_) |
void | set_ymaxStat (Mdouble ymaxStat_) |
void | set_zmaxStat (Mdouble zmaxStat_) |
int | get_nTimeAverage () |
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 | set_PolynomialName (const char *new_name) |
std::string | get_PolynomialName () |
void | set_doublePoints (bool new_) |
bool | get_doublePoints () |
void | set_TimeAverageReset (int new_) |
bool | get_TimeAverageReset () |
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) |
template<> | |
void | set_nz (int new_ UNUSED) |
template<> | |
void | set_ny (int new_ UNUSED) |
template<> | |
void | set_nx (int new_ UNUSED) |
template<> | |
void | set_ny (int new_ UNUSED) |
template<> | |
void | set_nz (int new_ UNUSED) |
template<> | |
void | set_nx (int new_ UNUSED) |
template<> | |
void | set_nz (int new_ UNUSED) |
template<> | |
void | set_nx (int new_ UNUSED) |
template<> | |
void | set_ny (int new_ UNUSED) |
template<> | |
void | set_nx (int new_ UNUSED) |
template<> | |
void | set_ny (int new_ UNUSED) |
template<> | |
void | set_nz (int new_ UNUSED) |
template<> | |
void | set_statType () |
template<> | |
void | set_statType () |
template<> | |
void | set_statType () |
template<> | |
void | set_statType () |
template<> | |
void | set_statType () |
template<> | |
void | set_statType () |
template<> | |
void | set_statType () |
template<> | |
void | set_statType () |
template<> | |
void | set_statType () |
template<> | |
void | set_statType () |
template<> | |
void | set_statType () |
template<> | |
void | set_statType () |
template<> | |
void | set_statType () |
template<> | |
void | set_statType () |
template<> | |
Mdouble | setInfinitelyLongDistance () |
template<> | |
Mdouble | setInfinitelyLongDistance () |
template<> | |
Mdouble | setInfinitelyLongDistance () |
template<> | |
Mdouble | setInfinitelyLongDistance () |
template<> | |
Mdouble | setInfinitelyLongDistance () |
template<> | |
Mdouble | setInfinitelyLongDistance () |
template<> | |
Mdouble | setInfinitelyLongDistance () |
template<> | |
Mdouble | setInfinitelyLongDistance () |
template<> | |
Mdouble | setInfinitelyLongDistance () |
template<> | |
Mdouble | setInfinitelyLongDistance () |
template<> | |
Mdouble | setInfinitelyLongDistance () |
template<> | |
Mdouble | setInfinitelyLongDistance () |
template<> | |
Mdouble | setInfinitelyLongDistance () |
template<> | |
double | setInfinitelyLongDistance () |
![]() | |
void | constructor () |
A public constructor, which sets defaults so the problem can be solved off the shelf. More... | |
MD () | |
MD (STD_save &other) | |
virtual | ~MD () |
void | info () |
Set up a virtual info this will be provided from the inhertiance. More... | |
void | solve () |
The work horse of the code. More... | |
void | solve (unsigned int argc, char *argv[]) |
Read arguments before solving. More... | |
void | solveWithMDCLR () |
Tries to solve the problem using MDCLR. More... | |
Mdouble | get_t () |
Access function for the time. More... | |
void | set_t (Mdouble new_t) |
Access function for the time. More... | |
int | get_NSpecies () |
Allows the number of Species to be accessed. More... | |
std::vector< CSpecies > & | get_Species (void) |
Allows the species to be copied. More... | |
CSpecies * | get_Species (int i) |
Allows the species to be accessed. More... | |
CSpecies * | get_MixedSpecies (int i, int j) |
Allows the mixed species to be accessed. More... | |
void | set_MixedSpecies (int i, int j, CSpecies &S) |
Allows the mixed species to be set. More... | |
void | set_tmax (Mdouble new_tmax) |
Allows the upper time limit to be changed. More... | |
Mdouble | get_tmax () |
Allows the upper time limit to be accessed. More... | |
ParticleHandler & | getParticleHandler () |
WallHandler & | getWallHandler () |
BoundaryHandler & | getBoundaryHandler () |
void | set_savecount (int new_) |
Allows the number of time steps between saves to be changed, see also set_number_of_saves. More... | |
void | set_save_count_all (int new_) |
void | set_save_count_data (int new_) |
void | set_save_count_ene (int new_) |
void | set_save_count_stat (int new_) |
void | set_save_count_fstat (int new_) |
int | get_savecount () |
Allows the number of time steps between saves to be accessed. More... | |
int | get_save_count () |
int | get_save_count_data () |
int | get_save_count_ene () |
int | get_save_count_stat () |
int | get_save_count_fstat () |
void | set_do_stat_always (bool new_) |
Sets how often the data is saved using the number of saves wanted, tmax, and dt. See also set_savecount. More... | |
void | set_number_of_saves (Mdouble N) |
void | set_number_of_saves_all (Mdouble N) |
void | set_number_of_saves_data (Mdouble N) |
void | set_number_of_saves_ene (Mdouble N) |
void | set_number_of_saves_stat (Mdouble N) |
void | set_number_of_saves_fstat (Mdouble N) |
void | set_plastic_k1_k2max_kc_depth (Mdouble k1_, Mdouble k2max_, Mdouble kc_, Mdouble depth_, unsigned int indSpecies=0) |
Allows the plastic constants to be changed. More... | |
void | set_k1 (Mdouble new_, unsigned int indSpecies=0) |
void | set_k2max (Mdouble new_, unsigned int indSpecies=0) |
void | set_kc (Mdouble new_, unsigned int indSpecies=0) |
void | set_depth (Mdouble new_, unsigned int indSpecies=0) |
Mdouble | get_k1 (unsigned int indSpecies=0) |
Allows the plastic constants to be accessed. More... | |
Mdouble | get_k2max (unsigned int indSpecies=0) |
Mdouble | get_kc (unsigned int indSpecies=0) |
Mdouble | get_depth (unsigned int indSpecies=0) |
Mdouble | get_plastic_dt (Mdouble mass, unsigned int indSpecies=0) |
void | set_k (Mdouble new_, unsigned int indSpecies=0) |
Allows the spring constant to be changed. More... | |
Mdouble | get_k (int indSpecies=0) |
Allows the spring constant to be accessed. More... | |
void | set_kt (Mdouble new_, unsigned int indSpecies=0) |
Allows the spring constant to be changed. More... | |
Mdouble | get_kt (int indSpecies=0) |
Allows the spring constant to be accessed. More... | |
void | set_krolling (Mdouble new_, unsigned int indSpecies=0) |
Allows the spring constant to be changed. More... | |
Mdouble | get_krolling (int indSpecies=0) |
Allows the spring constant to be accessed. More... | |
void | set_ktorsion (Mdouble new_, unsigned int indSpecies=0) |
Allows the spring constant to be changed. More... | |
Mdouble | get_ktorsion (int indSpecies=0) |
Allows the spring constant to be accessed. More... | |
void | set_rho (Mdouble new_, unsigned int indSpecies=0) |
Allows the density to be changed. More... | |
Mdouble | get_rho (int indSpecies=0) |
Allows the density to be accessed. More... | |
void | set_dispt (Mdouble new_, unsigned int indSpecies=0) |
Allows the tangential viscosity to be changed. More... | |
Mdouble | get_dispt (unsigned int indSpecies=0) |
Allows the tangential viscosity to be accessed. More... | |
void | set_disprolling (Mdouble new_, unsigned int indSpecies=0) |
Allows the tangential viscosity to be changed. More... | |
Mdouble | get_disprolling (unsigned int indSpecies=0) |
Allows the tangential viscosity to be accessed. More... | |
void | set_disptorsion (Mdouble new_, unsigned int indSpecies=0) |
Allows the tangential viscosity to be changed. More... | |
Mdouble | get_disptorsion (unsigned int indSpecies=0) |
Allows the tangential viscosity to be accessed. More... | |
void | set_disp (Mdouble new_, unsigned int indSpecies=0) |
Allows the normal dissipation to be changed. More... | |
Mdouble | get_disp (unsigned int indSpecies=0) |
Allows the normal dissipation to be accessed. More... | |
void | set_dissipation (Mdouble new_, unsigned int indSpecies=0) |
Allows the normal dissipation to be changed. More... | |
Mdouble | get_dissipation (unsigned int indSpecies=0) |
Allows the normal dissipation to be accessed. More... | |
void | set_mu (Mdouble new_, unsigned int indSpecies=0) |
Allows the Coulomb friction coefficient to be changed. More... | |
Mdouble | get_mu (unsigned int indSpecies=0) |
Allows the Coulomb friction coefficient to be accessed. More... | |
void | set_murolling (Mdouble new_, unsigned int indSpecies=0) |
Allows the Coulomb friction coefficient to be changed. More... | |
Mdouble | get_murolling (unsigned int indSpecies=0) |
Allows the Coulomb friction coefficient to be accessed. More... | |
void | set_mutorsion (Mdouble new_, unsigned int indSpecies=0) |
Allows the Coulomb friction coefficient to be changed. More... | |
Mdouble | get_mutorsion (unsigned int indSpecies=0) |
Allows the Coulomb friction coefficient to be accessed. More... | |
void | set_rotation (bool new_) |
bool | get_rotation () |
void | set_dim_particle (int new_, unsigned int indSpecies=0) |
Allows the dimension of the particle (f.e. for mass) to be changed. More... | |
int | get_dim_particle (unsigned int indSpecies=0) |
Allows the dimension of the particle (f.e. for mass) to be accessed. More... | |
bool | get_save_data_data () |
Returns the data counter. More... | |
bool | get_save_data_ene () |
bool | get_save_data_fstat () |
bool | get_save_data_stat () |
bool | get_do_stat_always () |
void | set_k_and_restitution_coefficient (Mdouble k_, Mdouble eps, Mdouble mass, unsigned int indSpecies=0) |
Sets k, disp such that it matches a given tc and eps for a collision of two copies of P. More... | |
void | set_collision_time_and_restitution_coefficient (Mdouble tc, Mdouble eps, Mdouble mass, unsigned int indSpecies=0) |
Sets k, disp such that it matches a given tc and eps for a collision of two copies of P. More... | |
void | set_collision_time_and_restitution_coefficient (Mdouble tc, Mdouble eps, Mdouble mass1, Mdouble mass2, unsigned int indSpecies=0) |
Set k, disp such that is matches a given tc and eps for a collision of two different masses. More... | |
void | set_collision_time_and_normal_and_tangential_restitution_coefficient (Mdouble tc, Mdouble eps, Mdouble beta, Mdouble mass1, Mdouble mass2, unsigned int indSpecies=0) |
See CSpecies::set_collision_time_and_normal_and_tangential_restitution_coefficient. More... | |
void | set_collision_time_and_normal_and_tangential_restitution_coefficient_nodispt (Mdouble tc, Mdouble eps, Mdouble beta, Mdouble mass1, Mdouble mass2, unsigned int indSpecies=0) |
See CSpecies::set_collision_time_and_normal_and_tangential_restitution_coefficient. More... | |
Mdouble | get_collision_time (Mdouble mass, unsigned int indSpecies=0) |
Calculates collision time for two copies of a particle of given disp, k, mass. More... | |
Mdouble | get_restitution_coefficient (Mdouble mass, unsigned int indSpecies=0) |
Calculates restitution coefficient for two copies of given disp, k, mass. More... | |
Mdouble | get_xmin () |
Get xmin. More... | |
Mdouble | get_xmax () |
Get xmax. More... | |
Mdouble | get_ymin () |
Gets ymin. More... | |
Mdouble | get_ymax () |
Gets ymax. More... | |
Mdouble | get_zmin () |
Gets zmin. More... | |
Mdouble | get_zmax () |
Gets zmax. More... | |
void | set_xmin (Mdouble new_xmin) |
Sets xmin and walls, assuming the standard definition of walls as in the default constructor. More... | |
void | set_ymin (Mdouble new_ymin) |
void | set_zmin (Mdouble new_zmin) |
Sets ymin and walls, assuming the standard definition of walls as in the default constructor. More... | |
void | set_xmax (Mdouble new_xmax) |
Sets xmax and walls, assuming the standard definition of walls as in the default constructor. More... | |
void | set_ymax (Mdouble new_ymax) |
Sets ymax and walls, assuming the standard definition of walls as in the default constructor. More... | |
void | set_zmax (Mdouble new_zmax) |
Sets ymax and walls, assuming the standard definition of walls as in the default constructor. More... | |
void | set_dt (Mdouble new_dt) |
Allows the time step dt to be changed. More... | |
Mdouble | get_dt () |
Allows the time step dt to be accessed. More... | |
void | set_name (const char *name) |
Sets the name of the problem, used for the same data files. More... | |
void | set_xballs_colour_mode (int new_cmode) |
Set the xball output mode. More... | |
void | set_xballs_cmode (int new_cmode) |
int | get_xballs_cmode () |
void | set_xballs_vector_scale (double new_vscale) |
Set the scale of vectors in xballs. More... | |
double | get_xballs_vscale () |
void | set_xballs_additional_arguments (std::string new_) |
Set the additional arguments for xballs. More... | |
std::string | get_xballs_additional_arguments () |
void | set_xballs_scale (Mdouble new_scale) |
Set the scale of the xballs problem. The default is fit to screen. More... | |
double | get_xballs_scale () |
void | set_gravity (Vec3D new_gravity) |
Allows the gravitational acceleration to be changed. More... | |
Vec3D | get_gravity () |
Allows the gravitational acceleration to be accessed. More... | |
void | set_dim (int new_dim) |
Allows the dimension of the simulation to be changed. More... | |
int | get_dim () |
Allows the dimension of the simulation to be accessed. More... | |
int | get_restart_version () |
Gets restart_version. More... | |
void | set_restart_version (int new_) |
Sets restart_version. More... | |
bool | get_restarted () |
Gets restarted. More... | |
Mdouble | get_max_radius () |
Sets restarted. More... | |
void | set_restarted (bool new_) |
bool | get_append () |
Gets restarted. More... | |
void | set_append (bool new_) |
Sets restarted. More... | |
Mdouble | get_ene_ela () |
Gets ene_ela. More... | |
void | set_ene_ela (Mdouble new_) |
Sets ene_ela. More... | |
void | add_ene_ela (Mdouble new_) |
Sets ene_ela. More... | |
void | Remove_Particle (int IP) |
This function removes partice IP from the vector of particles by moving the last particle in the vector to the position if IP Also it checks if the moved Particle has any tangentialsspring-information, which needs to be moved to a different particle, because tangential spring information always needs to be stored in the real particle with highest particle index. More... | |
Mdouble | get_Mass_from_Radius (Mdouble radius, int indSpecies=0) |
Mdouble | get_maximum_velocity (BaseParticle &P) |
Calculates the maximum velocity allowed for a collision of two copies of P (for higher velocities particles could pass through each other) More... | |
virtual BaseParticle * | getSmallestParticle () |
virtual BaseParticle * | getLargestParticle () |
virtual void | removeParticle (int iP) |
Mdouble | get_maximum_velocity () |
void | set_dt_by_mass (Mdouble mass) |
Sets dt to 1/50-th of the collision time for two particles of mass P. More... | |
void | set_dt (BaseParticle &P) |
Sets dt to 1/50-th of the collision time for two copies of P. More... | |
void | set_dt () |
Sets dt to 1/50-th of the smallest possible collision time. More... | |
virtual void | setup_particles_initial_conditions () |
This function allows the initial conditions of the particles to be set, by default locations is random. More... | |
virtual void | create_xballs_script () |
This creates a scipt which can be used to load the xballs problem to display the data just generated. More... | |
virtual double | getInfo (BaseParticle &P) |
Allows the user to set what is written into the info column in the data file. By default is store the Species ID number. More... | |
virtual void | save_restart_data () |
Stores all MD data. More... | |
int | load_restart_data () |
Loads all MD data. More... | |
int | load_restart_data (std::string filename) |
void | statistics_from_restart_data (const char *name) |
Loads all MD data and plots statistics for all timesteps in the .data file. More... | |
virtual void | write (std::ostream &os) |
Writes all MD data. More... | |
virtual void | read (std::istream &is) |
Reads all MD data. More... | |
virtual void | write_v1 (std::ostream &os) |
Writes all MD data. More... | |
virtual void | read_v1 (std::istream &is) |
Reads all MD data. More... | |
virtual void | read_v2 (std::istream &is) |
bool | load_from_data_file (const char *filename, unsigned int format=0) |
This allows particle data to be reloaded from data files. More... | |
bool | load_par_ini_file (const char *filename) |
allows the user to read par.ini files (useful to read MDCLR files) More... | |
bool | read_next_from_data_file (unsigned int format=0) |
by default format do not pass an argument; only specify format if you have to read a special format (f.e. dim=2, but format=14 (3d format)) More... | |
int | read_dim_from_data_file () |
bool | find_next_data_file (Mdouble tmin, bool verbose=true) |
virtual void | print (std::ostream &os, bool print_all=false) |
Outputs MD. More... | |
void | add_Species (CSpecies &S) |
void | add_Species (void) |
void | set_format (int new_) |
int | get_format () |
int | readArguments (unsigned int argc, char *argv[]) |
Can interpret main function input arguments that are passed by the driver codes. More... | |
virtual int | readNextArgument (unsigned int &i, unsigned int argc, char *argv[]) |
![]() | |
STD_save () | |
Default constructor: sets the counter to 0 (i.e. no number will be included). More... | |
STD_save (STD_save &other) | |
Copy constructor. More... | |
void | constructor () |
void | inc_counter_in_file () |
Increament the counter value stored in the file_counter by 1 and store the new value. More... | |
int | read_run_num_from_file () |
Read rom the counter file the counter. More... | |
void | set_counter_from_file () |
Sets the counter based on the current number stored in the counter file. More... | |
void | save_info_to_disk () |
Saves the information generated by info to disk in a file. More... | |
void | set_counter (int new_counter) |
This set the counter, overriding the defaults. More... | |
int | get_counter () |
This returns the current value of the counter. More... | |
bool | FileExists (std::string strFilename) |
Function to check if a file exists, is used to check if a run has already need done. More... | |
void | auto_number () |
std::vector< int > | get_numbers (int size_x, int size_y) |
This turns a counter into two indexs for doing parmater studies. The indexs run from 1:size_x and 1:size_y where as the study number starts at 0. More... | |
int | launch_new (const char *name, bool quick=false) |
This launch a code from within this code. Please pass the name of the code to run. More... | |
void | set_name (const char *name) |
Sets the name of the problem, used for the same data files. More... | |
std::string | get_name () |
Allows the problem_name to be accessed. More... | |
std::fstream & | get_data_file () |
Allows the problem_name to be accessed. More... | |
std::fstream & | get_stat_file () |
Allows the problem_name to be accessed. More... | |
std::fstream & | get_fstat_file () |
Allows the problem_name to be accessed. More... | |
std::fstream & | get_ene_file () |
Allows the problem_name to be accessed. More... | |
void | set_fstat_filename (std::string filename) |
void | set_data_filename (std::string filename) |
void | set_stat_filename (std::string filename) |
void | set_ene_filename (std::string filename) |
void | set_fstat_filename () |
void | set_data_filename () |
void | set_stat_filename () |
void | set_ene_filename () |
std::string | get_fstat_filename () |
std::string | get_data_filename () |
std::string | get_stat_filename () |
std::string | get_ene_filename () |
void | set_step_size (unsigned int new_) |
unsigned int | get_step_size () |
void | set_options_fstat (unsigned int new_) |
set and get for file options More... | |
unsigned int | get_options_fstat (void) |
void | set_options_data (unsigned int new_) |
unsigned int | get_options_data (void) |
void | set_options_stat (unsigned int new_) |
unsigned int | get_options_stat (void) |
void | set_options_restart (unsigned int new_) |
unsigned int | get_options_restart (void) |
void | set_options_ene (unsigned int new_) |
unsigned int | get_options_ene (void) |
bool | open_file (std::fstream &file, std::string filename, unsigned int options, std::fstream::openmode mode) |
bool | open_fstat_file (std::fstream::openmode mode=std::fstream::out) |
bool | open_data_file (std::fstream::openmode mode=std::fstream::out) |
bool | open_stat_file (std::fstream::openmode mode=std::fstream::out) |
bool | open_ene_file (std::fstream::openmode mode=std::fstream::out) |
bool | open_counted_file (std::fstream &file, std::string filenameNoCount, std::fstream::openmode mode) |
opens file needed if data is written in multiple files More... | |
bool | increase_counter_fstat (std::fstream::openmode mode) |
bool | increase_counter_data (std::fstream::openmode mode) |
bool | increase_counter_stat (std::fstream::openmode mode) |
bool | increase_counter_ene (std::fstream::openmode mode) |
void | set_file_counter (int new_) |
int | get_file_counter () |
Protected Member Functions | |
bool | satisfiesInclusionCriteria (BaseParticle *P) |
bool | loadVelocityProfile (const char *filename) |
Vec3D | getVelocityProfile (Vec3D Position) |
bool | read_next_from_p3p_file () |
void | auto_setdim () |
![]() | |
virtual void | compute_all_forces () |
This does the force computation. More... | |
virtual void | compute_internal_forces (BaseParticle *i) |
Computes the forces between particles (internal in the sence that the sum over all these forces is zero i.e. fully modelled forces) More... | |
CTangentialSpring * | getTangentialSpring (BaseParticle *PI, BaseParticle *PJ, BaseParticle *PJreal) |
CTangentialSpring * | getTangentialSpringWall (BaseParticle *pI, int w) |
virtual void | compute_internal_forces (BaseParticle *P1, BaseParticle *P2) |
Computes the forces between particles (internal in the sence that the sum over all these forces is zero i.e. fully modelled forces) More... | |
void | compute_plastic_internal_forces (BaseParticle *P1, BaseParticle *P2) |
Computes plastic forces between particles. More... | |
virtual void | compute_external_forces (BaseParticle *PI) |
This is were the computation of external forces takes place (e.g. gravity) More... | |
virtual void | compute_walls (BaseParticle *PI) |
This is were the walls are. More... | |
Mdouble | computeShortRangeForceWithWall (BaseParticle *pI, int wall, CSpecies *pSpecies, Mdouble dist) |
Mdouble | computeShortRangeForceWithParticle (BaseParticle *PI, BaseParticle *PJ, BaseParticle *PJreal, CSpecies *pSpecies, Mdouble dist) |
virtual void | actions_before_time_loop () |
This is actions before the start of the main time loop. More... | |
virtual void | HGRID_actions_before_time_loop () |
This is actions before the start of the main time loop. More... | |
virtual void | HGRID_actions_before_time_step () |
This is action before the time step is started. More... | |
virtual void | HGRID_InsertParticleToHgrid (BaseParticle *obj UNUSED) |
This is action before the time step is started. More... | |
virtual void | HGRID_UpdateParticleInHgrid (BaseParticle *obj UNUSED) |
virtual void | HGRID_RemoveParticleFromHgrid (BaseParticle *obj UNUSED) |
virtual bool | get_HGRID_UpdateEachTimeStep () |
virtual void | actions_before_time_step () |
This is action before the time step is started. More... | |
virtual void | actions_after_solve () |
This is actions at the end of the code, but before the files are closed. More... | |
virtual void | actions_after_time_step () |
This is action after the time step is finished. More... | |
virtual void | output_xballs_data () |
Output xball data for Particle i. More... | |
virtual void | output_xballs_data_particle (int i) |
This function outputs the location and velocity of the particle in a format the xballs progream can read. More... | |
virtual void | start_ene () |
Functions for ene file. More... | |
virtual void | fstat_header () |
virtual void | output_ene () |
This function outputs statistical data - The default is to compute the rotational kinetic engergy, linear kinetic energy, and the centre of mass. More... | |
virtual void | set_initial_pressures_for_pressure_controlled_walls () |
virtual void | do_integration_before_force_computation (BaseParticle *pI) |
This is were the integration is done. More... | |
virtual void | checkInteractionWithBoundaries () |
virtual void | HGRID_update_move (BaseParticle *, Mdouble) |
virtual void | HGRID_actions_before_integration () |
virtual void | HGRID_actions_after_integration () |
virtual void | do_integration_after_force_computation (BaseParticle *pI) |
This is were the integration is done. More... | |
virtual void | InitBroadPhase () |
Initialisation of Broad Phase Information (Default no Broad Phase so empty) More... | |
virtual void | broad_phase (BaseParticle *i) |
Broad phase of contact detection goes here. Default check all contacts. More... | |
void | set_FixedParticles (unsigned int n) |
void | initialize_tangential_springs () |
void | compute_particle_masses () |
Computes the mass of each particle. More... | |
virtual void | cout_time () |
std::couts time More... | |
virtual bool | continue_solve () |
void | reset_DeltaMax () |
sets the history parameter DeltaMax of all particles to zero More... | |
void | reset_TangentialSprings () |
sets the history parameter TangentialSprings of all particles to zero 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 points of evaluation are placed in an grid on the domain [xminStat,xmaxStat]x[yminStat,ymaxStat]x[zminStat,zmaxStat]. 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 |
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 More... | |
int | verbosity |
0 no output 1 basic output (timesteps) 2 full output (number of forces and particles, md and stat parameters) More... | |
int | format |
Mdouble | mirrorAtDomainBoundary |
bool | isMDCLR |
bool | superexact |
If true, cutoff radius for Gaussian is set to 5*w (from 3*w) More... | |
bool | doublePoints |
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 |
![]() | |
std::vector< CSpecies > | Species |
These are the particle parameters like dissipation etc. More... | |
![]() | |
std::stringstream | problem_name |
Stores the problem_name. More... | |
std::stringstream | data_filename |
These store the save file names, by default they are derived from problem_name. More... | |
std::stringstream | stat_filename |
std::stringstream | fstat_filename |
std::stringstream | ene_filename |
std::fstream | data_file |
Stream used for data files. More... | |
std::fstream | stat_file |
std::fstream | fstat_file |
std::fstream | ene_file |
unsigned int | options_fstat |
Indicators if files are created or not 0: file will not be created 1: file will be written in one file 2: file will be written in multiple files. More... | |
unsigned int | options_data |
unsigned int | options_stat |
unsigned int | options_ene |
unsigned int | options_restart |
unsigned int | file_counter |
Counter needed if file will be written in multiple files. More... | |
unsigned int | step_size |
Additional Inherited Members | |
![]() | |
RNG | random |
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 30 of file StatisticsPoint.h.
|
inline |
Basic constructor only calls constructor()
Definition at line 56 of file StatisticsVector.h.
References StatisticsVector< T >::constructor().
|
inline |
Definition at line 57 of file StatisticsVector.h.
References StatisticsVector< T >::constructor().
StatisticsVector< T >::StatisticsVector | ( | StatisticsVector< T > & | other | ) |
Copy constructor.
Definition at line 139 of file StatisticsVector.hcc.
References StatisticsVector< T >::CG_type, StatisticsVector< T >::CGPolynomial, StatisticsVector< T >::constructor(), StatisticsVector< T >::cutoff, StatisticsVector< T >::cutoff2, StatisticsVector< T >::doGradient, StatisticsVector< T >::doTimeAverage, StatisticsVector< T >::doVariance, StatisticsVector< T >::dx, StatisticsVector< T >::dxTimeAverage, StatisticsVector< T >::dy, StatisticsVector< T >::dyTimeAverage, StatisticsVector< T >::dz, StatisticsVector< T >::dzTimeAverage, StatisticsVector< T >::format, StatisticsVector< T >::hmax, StatisticsVector< T >::ignoreFixedParticles, StatisticsVector< T >::indSpecies, StatisticsVector< T >::isMDCLR, StatisticsVector< T >::mirrorAtDomainBoundary, StatisticsVector< T >::nTimeAverage, StatisticsVector< T >::nx, StatisticsVector< T >::nxMirrored, StatisticsVector< T >::ny, StatisticsVector< T >::nyMirrored, StatisticsVector< T >::nz, StatisticsVector< T >::nzMirrored, StatisticsVector< T >::periodicWalls, StatisticsVector< T >::Points, StatisticsVector< T >::rmax, StatisticsVector< T >::rmin, StatisticsVector< T >::StressTypeForFixedParticles, StatisticsVector< T >::superexact, StatisticsVector< T >::timeAverage, StatisticsVector< T >::timeVariance, StatisticsVector< T >::tintStat, StatisticsVector< T >::tmaxStat, StatisticsVector< T >::tminStat, StatisticsVector< T >::verbosity, StatisticsVector< T >::w2, StatisticsVector< T >::w_over_rmax, StatisticsVector< T >::walls, StatisticsVector< T >::xmaxStat, StatisticsVector< T >::xminStat, StatisticsVector< T >::ymaxStat, StatisticsVector< T >::yminStat, StatisticsVector< T >::zmaxStat, and StatisticsVector< T >::zminStat.
StatisticsVector< T >::StatisticsVector | ( | unsigned int | argc, |
char * | argv[] | ||
) |
Advanced constructor that accepts arguments from the command line.
Definition at line 224 of file StatisticsVector.hcc.
|
protected |
Definition at line 948 of file StatisticsVector.hcc.
StatisticsPoint< T > StatisticsVector< T >::average | ( | std::vector< StatisticsPoint< T > > & | P | ) |
Output average of statistical variables.
Output names of statistical variables.
Definition at line 649 of file StatisticsVector.hcc.
References StatisticsPoint< T >::set_zero().
|
inline |
Definition at line 91 of file StatisticsVector.h.
References MD::get_dt(), MD::get_t(), StatisticsVector< T >::get_tmaxStat(), and StatisticsVector< T >::get_tminStat().
void StatisticsVector< T >::constructor | ( | ) |
Sets up all basic things.
Definition at line 74 of file StatisticsVector.hcc.
References Gaussian, and StatisticsPoint< T >::set_gb().
Referenced by StatisticsVector< T >::StatisticsVector().
void StatisticsVector< T >::constructor | ( | std::string | name | ) |
Definition at line 202 of file StatisticsVector.hcc.
void StatisticsVector< T >::evaluate_force_statistics | ( | int | wp = 0 | ) |
get force statistics
todo{What are P1 and P2 over here?}
Definition at line 1719 of file StatisticsVector.hcc.
References Cross(), PeriodicBoundary::distance(), PeriodicBoundary::shift_positions(), Vec3D::X, Vec3D::Y, and Vec3D::Z.
void StatisticsVector< T >::evaluate_particle_statistics | ( | std::vector< BaseParticle * >::iterator | P, |
int | wp = 0 |
||
) |
Calculates statistics for a single Particle.
Definition at line 1851 of file StatisticsVector.hcc.
References Cross(), PeriodicBoundary::distance(), Dyadic(), MD::get_t(), PeriodicBoundary::shift_position(), sqr, SymmetrizedDyadic(), Vec3D::X, Vec3D::Y, and Vec3D::Z.
void StatisticsVector< T >::evaluate_wall_force_statistics | ( | Vec3D | P, |
int | wp = 0 |
||
) |
get force statistics (i.e. first particle is a wall particle)
todo{Whate are P1 and P2 over here?}
Definition at line 1787 of file StatisticsVector.hcc.
References PeriodicBoundary::distance(), PeriodicBoundary::shift_positions(), Vec3D::X, Vec3D::Y, and Vec3D::Z.
|
inline |
Definition at line 252 of file StatisticsVector.h.
References StatisticsVector< T >::CGPolynomial.
|
inline |
Definition at line 244 of file StatisticsVector.h.
References StatisticsVector< T >::CGPolynomial.
|
inline |
Definition at line 248 of file StatisticsVector.h.
References StatisticsVector< T >::CGPolynomial.
|
virtual |
Finish all statistics (i.e. write out final data)
Reimplemented from MD.
Definition at line 729 of file StatisticsVector.hcc.
void StatisticsVector< T >::gather_force_statistics_from_fstat_and_data | ( | ) |
get force statistics from particle collisions
Definition at line 1662 of file StatisticsVector.hcc.
void StatisticsVector< T >::gather_force_statistics_from_p3c | ( | int | version | ) |
get force statistics from particle collisions
Definition at line 1172 of file StatisticsVector.hcc.
References BaseParticle::get_Position(), and BaseParticle::get_Radius().
void StatisticsVector< T >::gather_force_statistics_from_p3w | ( | int | version, |
std::vector< int > & | index | ||
) |
get force statistics from particle collisions
Definition at line 1276 of file StatisticsVector.hcc.
References BaseParticle::get_Position(), and BaseParticle::get_Radius().
|
virtual |
Calculates statistics for one collision (can be any kind of collision)
2012Nov28TW I changed this from P1 to P2; was this mistake always there?
this is because wall-particle collisions appear only once in fstat
Note P1_P2 distance and normal are still in 3D, even for averages
todo{Difference here between direct and indirect statistics}
Reimplemented from MD.
Definition at line 1518 of file StatisticsVector.hcc.
References Dyadic(), sqr, SymmetrizedDyadic(), and Vec3D::Z.
|
inline |
Definition at line 95 of file StatisticsVector.h.
References StatisticsVector< T >::CG_type.
|
inline |
Definition at line 108 of file StatisticsVector.h.
References StatisticsVector< T >::cutoff.
|
inline |
Definition at line 109 of file StatisticsVector.h.
References StatisticsVector< T >::cutoff, and sqr.
|
inline |
Definition at line 144 of file StatisticsVector.h.
References StatisticsVector< T >::doGradient.
|
inline |
Definition at line 129 of file StatisticsVector.h.
References StatisticsVector< T >::doTimeAverage.
|
inline |
|
inline |
Definition at line 141 of file StatisticsVector.h.
References StatisticsVector< T >::doVariance.
|
inline |
Definition at line 150 of file StatisticsVector.h.
References StatisticsVector< T >::ignoreFixedParticles.
|
inline |
Definition at line 138 of file StatisticsVector.h.
References StatisticsVector< T >::mirrorAtDomainBoundary.
|
inline |
Definition at line 98 of file StatisticsVector.h.
References StatisticsVector< T >::nx, StatisticsVector< T >::ny, and StatisticsVector< T >::nz.
|
inline |
Definition at line 212 of file StatisticsVector.h.
References StatisticsVector< T >::nTimeAverage.
|
inline |
Definition at line 82 of file StatisticsVector.h.
References StatisticsVector< T >::nx.
|
inline |
|
inline |
|
inline |
Definition at line 160 of file StatisticsVector.h.
References StatisticsVector< T >::periodicWalls.
|
inline |
Definition at line 197 of file StatisticsVector.h.
References StatisticsVector< T >::Points.
|
inline |
Definition at line 228 of file StatisticsVector.h.
References StatisticsVector< T >::CGPolynomial.
|
inline |
Definition at line 132 of file StatisticsVector.h.
References StatisticsVector< T >::StressTypeForFixedParticles.
|
inline |
Definition at line 147 of file StatisticsVector.h.
References StatisticsVector< T >::superexact.
|
inline |
Definition at line 238 of file StatisticsVector.h.
References StatisticsVector< T >::nTimeAverageReset.
|
inline |
Definition at line 90 of file StatisticsVector.h.
References StatisticsVector< T >::tintStat.
|
inline |
Definition at line 89 of file StatisticsVector.h.
References MD::get_tmax(), and StatisticsVector< T >::tmaxStat.
Referenced by StatisticsVector< T >::check_current_time_for_statistics().
|
inline |
Definition at line 88 of file StatisticsVector.h.
References StatisticsVector< T >::tminStat.
Referenced by StatisticsVector< T >::check_current_time_for_statistics().
|
inline |
Definition at line 154 of file StatisticsVector.h.
References StatisticsVector< T >::verbosity.
|
inline |
Definition at line 106 of file StatisticsVector.h.
References StatisticsVector< T >::w2.
|
inline |
Definition at line 107 of file StatisticsVector.h.
References StatisticsVector< T >::w2.
|
inline |
Definition at line 163 of file StatisticsVector.h.
References StatisticsVector< T >::w_over_rmax.
|
inline |
Definition at line 157 of file StatisticsVector.h.
References StatisticsVector< T >::walls.
|
inline |
Definition at line 203 of file StatisticsVector.h.
References MD::get_xmax(), and StatisticsVector< T >::xmaxStat.
Referenced by StatisticsVector< T >::set_hx().
|
inline |
Functions to acces and change the domain of statistics.
Definition at line 200 of file StatisticsVector.h.
References MD::get_xmin(), and StatisticsVector< T >::xminStat.
Referenced by StatisticsVector< T >::set_hx().
|
inline |
Definition at line 204 of file StatisticsVector.h.
References MD::get_ymax(), and StatisticsVector< T >::ymaxStat.
Referenced by StatisticsVector< T >::set_hy().
|
inline |
Definition at line 201 of file StatisticsVector.h.
References MD::get_ymin(), and StatisticsVector< T >::yminStat.
Referenced by StatisticsVector< T >::set_hy().
|
inline |
Definition at line 205 of file StatisticsVector.h.
References MD::get_zmax(), and StatisticsVector< T >::zmaxStat.
Referenced by StatisticsVector< T >::set_hz().
|
inline |
Definition at line 202 of file StatisticsVector.h.
References MD::get_zmin(), and StatisticsVector< T >::zminStat.
Referenced by StatisticsVector< T >::set_hz().
|
protected |
Definition at line 307 of file StatisticsVector.hcc.
References X, Vec3D::X, Y, Vec3D::Y, Z, and Vec3D::Z.
|
virtual |
Initializes statistics, i.e. setting w2, setting the grid and writing the header lines in the .stat file.
This creates the file statistics will be saved to
Reimplemented from MD.
Definition at line 658 of file StatisticsVector.hcc.
References StatisticsVector< T >::set_Positions(), and StatisticsVector< T >::set_w2().
void StatisticsVector< T >::jump_fstat | ( | ) |
Definition at line 1493 of file StatisticsVector.hcc.
void StatisticsVector< T >::jump_p3c | ( | ) |
get force statistics from particle collisions
Definition at line 1136 of file StatisticsVector.hcc.
|
protected |
Definition at line 247 of file StatisticsVector.hcc.
References Vec3D::X, Vec3D::Y, and Vec3D::Z.
|
virtual |
Calculates statistics for Particles (i.e. not collisions)
Because the domain can change in size some stuff has to be updated
Reimplemented from MD.
Definition at line 1826 of file StatisticsVector.hcc.
std::string StatisticsVector< T >::print | ( | ) |
Outputs member variable values to a std::string.
Outputs StatisticsVector.
Definition at line 584 of file StatisticsVector.hcc.
References Gaussian, HeavisideSphere, and Polynomial.
std::string StatisticsVector< T >::print_CG | ( | ) |
Output coarse graining variables.
Output names of statistical variables.
Definition at line 619 of file StatisticsVector.hcc.
References Polynomial.
void StatisticsVector< T >::print_help | ( | ) |
Definition at line 476 of file StatisticsVector.hcc.
|
virtual |
Processes all gathered statistics and resets them afterwards. (Processing means either calculating time averages or writing out statistics)
Reimplemented from MD.
Definition at line 736 of file StatisticsVector.hcc.
bool StatisticsVector< T >::read_next_from_data_file | ( | unsigned int | format | ) |
Definition at line 687 of file StatisticsVector.hcc.
References MD::read_next_from_data_file().
|
protected |
Definition at line 968 of file StatisticsVector.hcc.
References constants::pi.
void StatisticsVector< T >::readStatArguments | ( | unsigned int | argc, |
char * | argv[] | ||
) |
Definition at line 331 of file StatisticsVector.hcc.
References Gaussian, and HeavisideSphere.
|
virtual |
Set all statistical variables to zero.
Definition at line 63 of file StatisticsVector.hcc.
|
protected |
Definition at line 1511 of file StatisticsVector.hcc.
References BaseParticle::get_Position(), BaseParticle::get_Radius(), and Vec3D::Z.
void StatisticsVector< T >::set_CG_type | ( | const char * | new_ | ) |
Definition at line 548 of file StatisticsVector.hcc.
References Gaussian, HeavisideSphere, and Polynomial.
void StatisticsVector< T >::set_CG_type | ( | CG | new_ | ) |
Definition at line 577 of file StatisticsVector.hcc.
References Polynomial.
|
inline |
Definition at line 143 of file StatisticsVector.h.
References StatisticsVector< T >::doGradient.
|
inline |
Definition at line 128 of file StatisticsVector.h.
References StatisticsVector< T >::doTimeAverage.
|
inline |
|
inline |
Definition at line 140 of file StatisticsVector.h.
References StatisticsVector< T >::doVariance.
|
inline |
Definition at line 81 of file StatisticsVector.h.
References StatisticsVector< T >::set_hx(), StatisticsVector< T >::set_hy(), and StatisticsVector< T >::set_hz().
|
inline |
Definition at line 242 of file StatisticsVector.h.
References StatisticsVector< T >::hmax.
|
inline |
Definition at line 75 of file StatisticsVector.h.
References StatisticsVector< T >::get_xmaxStat(), StatisticsVector< T >::get_xminStat(), and StatisticsVector< T >::set_nx().
Referenced by StatisticsVector< T >::set_h().
|
inline |
Definition at line 77 of file StatisticsVector.h.
References StatisticsVector< T >::get_ymaxStat(), StatisticsVector< T >::get_yminStat(), and StatisticsVector< T >::set_ny().
Referenced by StatisticsVector< T >::set_h().
|
inline |
Definition at line 79 of file StatisticsVector.h.
References StatisticsVector< T >::get_zmaxStat(), StatisticsVector< T >::get_zminStat(), and StatisticsVector< T >::set_nz().
Referenced by StatisticsVector< T >::set_h().
|
inline |
Definition at line 149 of file StatisticsVector.h.
References StatisticsVector< T >::ignoreFixedParticles.
|
inline |
Definition at line 135 of file StatisticsVector.h.
References StatisticsVector< T >::StressTypeForFixedParticles.
|
inline |
Definition at line 137 of file StatisticsVector.h.
References StatisticsVector< T >::mirrorAtDomainBoundary.
|
inline |
Definition at line 80 of file StatisticsVector.h.
References StatisticsVector< T >::set_nx(), StatisticsVector< T >::set_ny(), and StatisticsVector< T >::set_nz().
|
inline |
Definition at line 97 of file StatisticsVector.h.
References StatisticsVector< T >::nx, StatisticsVector< T >::ny, and StatisticsVector< T >::nz.
|
inline |
Definition at line 74 of file StatisticsVector.h.
References StatisticsVector< T >::nx.
Referenced by StatisticsVector< T >::set_hx(), and StatisticsVector< T >::set_n().
void StatisticsVector< YZ >::set_nx | ( | int new_ | UNUSED | ) |
Definition at line 1955 of file StatisticsVector.hcc.
void StatisticsVector< Y >::set_nx | ( | int new_ | UNUSED | ) |
Definition at line 1958 of file StatisticsVector.hcc.
void StatisticsVector< Z >::set_nx | ( | int new_ | UNUSED | ) |
Definition at line 1960 of file StatisticsVector.hcc.
void StatisticsVector< O >::set_nx | ( | int new_ | UNUSED | ) |
Definition at line 1962 of file StatisticsVector.hcc.
|
inline |
Definition at line 76 of file StatisticsVector.h.
References StatisticsVector< T >::ny.
Referenced by StatisticsVector< T >::set_hy(), and StatisticsVector< T >::set_n().
void StatisticsVector< XZ >::set_ny | ( | int new_ | UNUSED | ) |
Definition at line 1954 of file StatisticsVector.hcc.
void StatisticsVector< X >::set_ny | ( | int new_ | UNUSED | ) |
Definition at line 1956 of file StatisticsVector.hcc.
void StatisticsVector< Z >::set_ny | ( | int new_ | UNUSED | ) |
Definition at line 1961 of file StatisticsVector.hcc.
void StatisticsVector< O >::set_ny | ( | int new_ | UNUSED | ) |
Definition at line 1963 of file StatisticsVector.hcc.
|
inline |
Definition at line 78 of file StatisticsVector.h.
References MD::get_dim(), and StatisticsVector< T >::nz.
Referenced by StatisticsVector< T >::set_hz(), and StatisticsVector< T >::set_n().
void StatisticsVector< XY >::set_nz | ( | int new_ | UNUSED | ) |
Definition at line 1953 of file StatisticsVector.hcc.
void StatisticsVector< X >::set_nz | ( | int new_ | UNUSED | ) |
Definition at line 1957 of file StatisticsVector.hcc.
void StatisticsVector< Y >::set_nz | ( | int new_ | UNUSED | ) |
Definition at line 1959 of file StatisticsVector.hcc.
void StatisticsVector< O >::set_nz | ( | int new_ | UNUSED | ) |
Definition at line 1964 of file StatisticsVector.hcc.
|
inline |
Definition at line 159 of file StatisticsVector.h.
References StatisticsVector< T >::periodicWalls.
Referenced by Statistics().
|
inline |
Definition at line 216 of file StatisticsVector.h.
References StatisticsVector< T >::CGPolynomial.
|
inline |
Definition at line 220 of file StatisticsVector.h.
References StatisticsVector< T >::CGPolynomial.
|
inline |
Definition at line 224 of file StatisticsVector.h.
References StatisticsVector< T >::CGPolynomial.
void StatisticsVector< T >::set_Positions | ( | ) |
Set position of StatisticsPoint points and set variables to 0.
Set position of statistics points and set variables to 0.
Definition at line 1365 of file StatisticsVector.hcc.
References A, AZ, R, RA, RAZ, RZ, X, Vec3D::X, XY, XYZ, XZ, Y, Vec3D::Y, YZ, Z, and Vec3D::Z.
Referenced by StatisticsVector< T >::initialize_statistics().
|
inline |
Definition at line 241 of file StatisticsVector.h.
References StatisticsVector< T >::rmax.
|
inline |
Definition at line 240 of file StatisticsVector.h.
References StatisticsVector< T >::rmin.
void StatisticsVector< T >::set_statType | ( | ) |
void StatisticsVector< RAZ >::set_statType | ( | ) |
Definition at line 1966 of file StatisticsVector.hcc.
References RAZ.
void StatisticsVector< RZ >::set_statType | ( | ) |
Definition at line 1967 of file StatisticsVector.hcc.
References RZ.
void StatisticsVector< AZ >::set_statType | ( | ) |
Definition at line 1968 of file StatisticsVector.hcc.
References AZ.
void StatisticsVector< RA >::set_statType | ( | ) |
Definition at line 1969 of file StatisticsVector.hcc.
References RA.
void StatisticsVector< A >::set_statType | ( | ) |
Definition at line 1970 of file StatisticsVector.hcc.
References A.
void StatisticsVector< R >::set_statType | ( | ) |
Definition at line 1971 of file StatisticsVector.hcc.
References R.
void StatisticsVector< XYZ >::set_statType | ( | ) |
Definition at line 1972 of file StatisticsVector.hcc.
References XYZ.
void StatisticsVector< XY >::set_statType | ( | ) |
Definition at line 1973 of file StatisticsVector.hcc.
References XY.
void StatisticsVector< XZ >::set_statType | ( | ) |
Definition at line 1974 of file StatisticsVector.hcc.
References XZ.
void StatisticsVector< YZ >::set_statType | ( | ) |
Definition at line 1975 of file StatisticsVector.hcc.
References YZ.
void StatisticsVector< X >::set_statType | ( | ) |
Definition at line 1976 of file StatisticsVector.hcc.
References X.
void StatisticsVector< Y >::set_statType | ( | ) |
Definition at line 1977 of file StatisticsVector.hcc.
References Y.
void StatisticsVector< Z >::set_statType | ( | ) |
Definition at line 1978 of file StatisticsVector.hcc.
References Z.
void StatisticsVector< O >::set_statType | ( | ) |
Definition at line 1979 of file StatisticsVector.hcc.
References O.
|
inline |
Definition at line 131 of file StatisticsVector.h.
References StatisticsVector< T >::StressTypeForFixedParticles.
|
inline |
Definition at line 146 of file StatisticsVector.h.
References StatisticsVector< T >::superexact.
|
inline |
Definition at line 236 of file StatisticsVector.h.
References StatisticsVector< T >::nTimeAverageReset.
|
inline |
Definition at line 87 of file StatisticsVector.h.
References MD::t, and StatisticsVector< T >::tintStat.
|
inline |
Definition at line 86 of file StatisticsVector.h.
References MD::t, and StatisticsVector< T >::tmaxStat.
|
inline |
Definition at line 85 of file StatisticsVector.h.
References MD::t, and StatisticsVector< T >::tminStat.
|
inline |
Definition at line 153 of file StatisticsVector.h.
References StatisticsVector< T >::verbosity.
|
inline |
Set CG variables w2 and CG_invvolume.
Definition at line 101 of file StatisticsVector.h.
References StatisticsVector< T >::set_w2(), and sqr.
void StatisticsVector< T >::set_w2 | ( | Mdouble | new_ | ) |
Set CG variables w2 and CG_invvolume.
Definition at line 46 of file StatisticsVector.hcc.
References Gaussian, HeavisideSphere, Polynomial, and sqr.
Referenced by StatisticsVector< T >::initialize_statistics(), and StatisticsVector< T >::set_w().
|
inline |
Definition at line 162 of file StatisticsVector.h.
References StatisticsVector< T >::w_over_rmax.
|
inline |
Definition at line 156 of file StatisticsVector.h.
References StatisticsVector< T >::walls.
|
inline |
|
inline |
Definition at line 206 of file StatisticsVector.h.
References StatisticsVector< T >::xminStat.
|
inline |
|
inline |
|
inline |
|
inline |
Mdouble StatisticsVector< T >::setInfinitelyLongDistance | ( | ) |
Mdouble StatisticsVector< RAZ >::setInfinitelyLongDistance | ( | ) |
todo{check}
Definition at line 1981 of file StatisticsVector.hcc.
Mdouble StatisticsVector< RA >::setInfinitelyLongDistance | ( | ) |
Definition at line 1987 of file StatisticsVector.hcc.
Mdouble StatisticsVector< RZ >::setInfinitelyLongDistance | ( | ) |
Definition at line 1991 of file StatisticsVector.hcc.
Mdouble StatisticsVector< AZ >::setInfinitelyLongDistance | ( | ) |
Definition at line 1995 of file StatisticsVector.hcc.
Mdouble StatisticsVector< R >::setInfinitelyLongDistance | ( | ) |
Definition at line 1999 of file StatisticsVector.hcc.
Mdouble StatisticsVector< A >::setInfinitelyLongDistance | ( | ) |
Definition at line 2002 of file StatisticsVector.hcc.
Mdouble StatisticsVector< XYZ >::setInfinitelyLongDistance | ( | ) |
Definition at line 2007 of file StatisticsVector.hcc.
Mdouble StatisticsVector< XY >::setInfinitelyLongDistance | ( | ) |
Definition at line 2012 of file StatisticsVector.hcc.
Mdouble StatisticsVector< XZ >::setInfinitelyLongDistance | ( | ) |
Definition at line 2016 of file StatisticsVector.hcc.
Mdouble StatisticsVector< YZ >::setInfinitelyLongDistance | ( | ) |
Definition at line 2020 of file StatisticsVector.hcc.
Mdouble StatisticsVector< X >::setInfinitelyLongDistance | ( | ) |
Definition at line 2024 of file StatisticsVector.hcc.
Mdouble StatisticsVector< Y >::setInfinitelyLongDistance | ( | ) |
Definition at line 2027 of file StatisticsVector.hcc.
Mdouble StatisticsVector< Z >::setInfinitelyLongDistance | ( | ) |
Definition at line 2030 of file StatisticsVector.hcc.
double StatisticsVector< O >::setInfinitelyLongDistance | ( | ) |
Definition at line 2033 of file StatisticsVector.hcc.
void StatisticsVector< T >::statistics_from_fstat_and_data | ( | ) |
get StatisticsPoint
Definition at line 860 of file StatisticsVector.hcc.
References MD::print().
Referenced by Statistics().
void StatisticsVector< T >::statistics_from_p3 | ( | ) |
this is a modified version of statistics_from_fstat_and_data. It is used to read p3d files
Definition at line 1033 of file StatisticsVector.hcc.
References MD::create_xballs_script(), MD::output_xballs_data(), MD::print(), MD::save_restart_data(), MD::set_dim(), and MD::set_format().
|
inline |
Definition at line 152 of file StatisticsVector.h.
References StatisticsVector< T >::verbosity.
void StatisticsVector< T >::write_statistics | ( | ) |
Writes regular statistics.
Definition at line 705 of file StatisticsVector.hcc.
void StatisticsVector< T >::write_time_average_statistics | ( | ) |
Writes out time averaged statistics.
Definition at line 788 of file StatisticsVector.hcc.
References StatisticsPoint< T >::print().
|
protected |
coarse graining type (Gaussian, Heaviside, Polynomial)
Definition at line 309 of file StatisticsVector.h.
Referenced by StatisticsVector< T >::get_CG_type(), and StatisticsVector< T >::StatisticsVector().
|
protected |
Stores the Polynomial, if the cg function is an axisymmetric function Polynomial in r.
Definition at line 311 of file StatisticsVector.h.
Referenced by StatisticsVector< T >::evaluateIntegral(), StatisticsVector< T >::evaluatePolynomial(), StatisticsVector< T >::evaluatePolynomialGradient(), StatisticsVector< T >::get_PolynomialName(), StatisticsVector< T >::set_Polynomial(), StatisticsVector< T >::set_PolynomialName(), and StatisticsVector< T >::StatisticsVector().
|
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 317 of file StatisticsVector.h.
Referenced by StatisticsVector< T >::get_cutoff(), StatisticsVector< T >::get_cutoff2(), and StatisticsVector< T >::StatisticsVector().
|
protected |
Definition at line 317 of file StatisticsVector.h.
Referenced by StatisticsVector< T >::StatisticsVector().
|
protected |
Determines if gradient is outputted.
Definition at line 303 of file StatisticsVector.h.
Referenced by StatisticsVector< T >::get_doGradient(), StatisticsVector< T >::set_doGradient(), and StatisticsVector< T >::StatisticsVector().
|
protected |
Determines if output is averaged over time.
Definition at line 297 of file StatisticsVector.h.
Referenced by StatisticsVector< T >::get_doTimeAverage(), StatisticsVector< T >::set_doTimeAverage(), and StatisticsVector< T >::StatisticsVector().
|
protected |
Definition at line 363 of file StatisticsVector.h.
Referenced by StatisticsVector< T >::get_doublePoints(), and StatisticsVector< T >::set_doublePoints().
|
protected |
Determines if variance is outputted.
Definition at line 301 of file StatisticsVector.h.
Referenced by StatisticsVector< T >::get_doVariance(), StatisticsVector< T >::set_doVariance(), and StatisticsVector< T >::StatisticsVector().
|
protected |
A vector that stores the gradient in x of all statistical variables at a given position.
Definition at line 279 of file StatisticsVector.h.
Referenced by StatisticsVector< T >::StatisticsVector().
|
protected |
a vector used to sum up all statistical gradients in dx for time-averaging
Definition at line 291 of file StatisticsVector.h.
Referenced by StatisticsVector< T >::StatisticsVector().
|
protected |
A vector that stores the gradient in y of all statistical variables at a given position.
Definition at line 281 of file StatisticsVector.h.
Referenced by StatisticsVector< T >::StatisticsVector().
|
protected |
a vector used to sum up all statistical gradients in dy for time-averaging
Definition at line 293 of file StatisticsVector.h.
Referenced by StatisticsVector< T >::StatisticsVector().
|
protected |
A vector that stores the gradient in z of all statistical variables at a given position.
Definition at line 283 of file StatisticsVector.h.
Referenced by StatisticsVector< T >::StatisticsVector().
|
protected |
a vector used to sum up all statistical gradients in dz for time-averaging
Definition at line 295 of file StatisticsVector.h.
Referenced by StatisticsVector< T >::StatisticsVector().
|
protected |
Definition at line 355 of file StatisticsVector.h.
Referenced by StatisticsVector< T >::StatisticsVector().
|
protected |
defines the maximum height of the particles for which statistics are extracted
Definition at line 337 of file StatisticsVector.h.
Referenced by StatisticsVector< T >::set_hmax(), and StatisticsVector< T >::StatisticsVector().
|
protected |
Determines if fixed particles contribute to particle statistics (density, ...)
Definition at line 344 of file StatisticsVector.h.
Referenced by StatisticsVector< T >::get_ignoreFixedParticles(), StatisticsVector< T >::set_ignoreFixedParticles(), and StatisticsVector< T >::StatisticsVector().
|
protected |
defines the species for which statistics are extracted (-1 for all species)
Definition at line 330 of file StatisticsVector.h.
Referenced by StatisticsVector< T >::StatisticsVector().
|
protected |
Definition at line 358 of file StatisticsVector.h.
Referenced by StatisticsVector< T >::StatisticsVector().
|
protected |
Definition at line 356 of file StatisticsVector.h.
Referenced by StatisticsVector< T >::get_mirrorAtDomainBoundary(), StatisticsVector< T >::set_mirrorAtDomainBoundary(), and StatisticsVector< T >::StatisticsVector().
|
protected |
A counter needed to average over time.
Definition at line 305 of file StatisticsVector.h.
Referenced by StatisticsVector< T >::get_nTimeAverage(), and StatisticsVector< T >::StatisticsVector().
|
protected |
Determines after how many timesteps the time average is reset.
Definition at line 299 of file StatisticsVector.h.
Referenced by StatisticsVector< T >::get_TimeAverageReset(), and StatisticsVector< T >::set_TimeAverageReset().
|
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 264 of file StatisticsVector.h.
Referenced by StatisticsVector< T >::get_n(), StatisticsVector< T >::get_nx(), StatisticsVector< T >::set_n(), StatisticsVector< T >::set_nx(), and StatisticsVector< T >::StatisticsVector().
|
protected |
extension of grid size from mirrored points
Definition at line 273 of file StatisticsVector.h.
Referenced by StatisticsVector< T >::StatisticsVector().
|
protected |
see nx
Definition at line 266 of file StatisticsVector.h.
Referenced by StatisticsVector< T >::get_n(), StatisticsVector< T >::get_ny(), StatisticsVector< T >::set_n(), StatisticsVector< T >::set_ny(), and StatisticsVector< T >::StatisticsVector().
|
protected |
Definition at line 273 of file StatisticsVector.h.
Referenced by StatisticsVector< T >::StatisticsVector().
|
protected |
see nx
Definition at line 268 of file StatisticsVector.h.
Referenced by StatisticsVector< T >::get_n(), StatisticsVector< T >::get_nz(), StatisticsVector< T >::set_n(), StatisticsVector< T >::set_nz(), and StatisticsVector< T >::StatisticsVector().
|
protected |
Definition at line 273 of file StatisticsVector.h.
Referenced by StatisticsVector< T >::StatisticsVector().
|
protected |
Position of first contact point.
Definition at line 370 of file StatisticsVector.h.
|
protected |
not yet working
Definition at line 391 of file StatisticsVector.h.
|
protected |
Definition at line 381 of file StatisticsVector.h.
|
protected |
Definition at line 380 of file StatisticsVector.h.
|
protected |
not yet working
Definition at line 393 of file StatisticsVector.h.
|
protected |
Length of contact line.
Definition at line 376 of file StatisticsVector.h.
|
protected |
Fabric.
Definition at line 389 of file StatisticsVector.h.
|
protected |
Direction of contact.
Definition at line 374 of file StatisticsVector.h.
|
protected |
Contact stress from normal forces along the line of contact.
Definition at line 378 of file StatisticsVector.h.
|
protected |
Traction from normal forces at contact of flow with fixed particles or walls.
Definition at line 385 of file StatisticsVector.h.
|
protected |
not yet working
Definition at line 395 of file StatisticsVector.h.
|
protected |
Contact stress from tangential forces along the line of contact.
Definition at line 383 of file StatisticsVector.h.
|
protected |
Traction from tangential forces at contact of flow with fixed particles or walls.
Definition at line 387 of file StatisticsVector.h.
|
protected |
Position of second contact point.
Definition at line 372 of file StatisticsVector.h.
|
protected |
Definition at line 405 of file StatisticsVector.h.
|
protected |
Definition at line 404 of file StatisticsVector.h.
|
protected |
Definition at line 406 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 342 of file StatisticsVector.h.
Referenced by StatisticsVector< T >::get_periodicWalls(), StatisticsVector< T >::set_periodicWalls(), and StatisticsVector< T >::StatisticsVector().
|
protected |
A vector that stores the values of the statistical variables at a given position.
Definition at line 277 of file StatisticsVector.h.
Referenced by StatisticsVector< T >::get_Points(), and StatisticsVector< T >::StatisticsVector().
|
protected |
defines the maximum radius of the particles for which statistics are extracted
Definition at line 335 of file StatisticsVector.h.
Referenced by StatisticsVector< T >::set_rmax(), and StatisticsVector< T >::StatisticsVector().
|
protected |
defines the minimum radius of the particles for which statistics are extracted
Definition at line 333 of file StatisticsVector.h.
Referenced by StatisticsVector< T >::set_rmin(), and StatisticsVector< T >::StatisticsVector().
|
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 262 of file StatisticsVector.h.
|
protected |
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 349 of file StatisticsVector.h.
Referenced by StatisticsVector< T >::get_StressTypeForFixedParticles(), StatisticsVector< T >::set_infiniteStressForFixedParticles(), StatisticsVector< T >::set_StressTypeForFixedParticles(), and StatisticsVector< T >::StatisticsVector().
|
protected |
If true, cutoff radius for Gaussian is set to 5*w (from 3*w)
Definition at line 360 of file StatisticsVector.h.
Referenced by StatisticsVector< T >::get_superexact(), StatisticsVector< T >::set_superexact(), and StatisticsVector< T >::StatisticsVector().
|
protected |
A vector used to sum up all statistical values in Points for time-averaging.
Definition at line 287 of file StatisticsVector.h.
Referenced by StatisticsVector< T >::StatisticsVector().
|
protected |
a vector used to sum up the variance in time of all statistical values
Definition at line 289 of file StatisticsVector.h.
Referenced by StatisticsVector< T >::StatisticsVector().
|
protected |
Statistical output will only be created if tmaxStat-tintStat< t< tmaxStat.
Definition at line 328 of file StatisticsVector.h.
Referenced by StatisticsVector< T >::get_tintStat(), StatisticsVector< T >::set_tintStat(), and StatisticsVector< T >::StatisticsVector().
|
protected |
Statistical output will only be created if t<tmaxStat.
Definition at line 326 of file StatisticsVector.h.
Referenced by StatisticsVector< T >::get_tmaxStat(), StatisticsVector< T >::set_tmaxStat(), and StatisticsVector< T >::StatisticsVector().
|
protected |
Statistical output will only be created if t>tminStat.
Definition at line 324 of file StatisticsVector.h.
Referenced by StatisticsVector< T >::get_tminStat(), StatisticsVector< T >::set_tminStat(), and StatisticsVector< T >::StatisticsVector().
|
protected |
Definition at line 400 of file StatisticsVector.h.
|
protected |
Definition at line 402 of file StatisticsVector.h.
|
protected |
Definition at line 401 of file StatisticsVector.h.
|
protected |
0 no output 1 basic output (timesteps) 2 full output (number of forces and particles, md and stat parameters)
Definition at line 354 of file StatisticsVector.h.
Referenced by StatisticsVector< T >::get_verbosity(), StatisticsVector< T >::set_verbosity(), StatisticsVector< T >::StatisticsVector(), and StatisticsVector< T >::verbose().
|
protected |
coarse graining width squared; for HeavisideSphere and Gaussian
Definition at line 315 of file StatisticsVector.h.
Referenced by StatisticsVector< T >::get_w(), StatisticsVector< T >::get_w2(), and StatisticsVector< T >::StatisticsVector().
|
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 319 of file StatisticsVector.h.
Referenced by StatisticsVector< T >::get_w_over_rmax(), StatisticsVector< T >::set_w_over_rmax(), and StatisticsVector< T >::StatisticsVector().
|
protected |
Turns off walls before evaluation.
Definition at line 339 of file StatisticsVector.h.
Referenced by StatisticsVector< T >::get_walls(), StatisticsVector< T >::set_walls(), and StatisticsVector< T >::StatisticsVector().
|
protected |
Definition at line 271 of file StatisticsVector.h.
Referenced by StatisticsVector< T >::get_xmaxStat(), StatisticsVector< T >::set_xmaxStat(), and StatisticsVector< T >::StatisticsVector().
|
protected |
By default the points of evaluation are placed in an grid on the domain [xminStat,xmaxStat]x[yminStat,ymaxStat]x[zminStat,zmaxStat].
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 271 of file StatisticsVector.h.
Referenced by StatisticsVector< T >::get_xminStat(), StatisticsVector< T >::set_xminStat(), and StatisticsVector< T >::StatisticsVector().
|
protected |
Definition at line 271 of file StatisticsVector.h.
Referenced by StatisticsVector< T >::get_ymaxStat(), StatisticsVector< T >::set_ymaxStat(), and StatisticsVector< T >::StatisticsVector().
|
protected |
Definition at line 271 of file StatisticsVector.h.
Referenced by StatisticsVector< T >::get_yminStat(), StatisticsVector< T >::set_yminStat(), and StatisticsVector< T >::StatisticsVector().
|
protected |
Definition at line 271 of file StatisticsVector.h.
Referenced by StatisticsVector< T >::get_zmaxStat(), StatisticsVector< T >::set_zmaxStat(), and StatisticsVector< T >::StatisticsVector().
|
protected |
Definition at line 271 of file StatisticsVector.h.
Referenced by StatisticsVector< T >::get_zminStat(), StatisticsVector< T >::set_zminStat(), and StatisticsVector< T >::StatisticsVector().