Changeset 7ba268 for src/Analysis


Ignore:
Timestamp:
Nov 3, 2011, 9:52:29 AM (13 years ago)
Author:
Frederik Heber <heber@…>
Branches:
Action_Thermostats, Add_AtomRandomPerturbation, Add_FitFragmentPartialChargesAction, Add_RotateAroundBondAction, Add_SelectAtomByNameAction, Added_ParseSaveFragmentResults, AddingActions_SaveParseParticleParameters, Adding_Graph_to_ChangeBondActions, Adding_MD_integration_tests, Adding_ParticleName_to_Atom, Adding_StructOpt_integration_tests, AtomFragments, Automaking_mpqc_open, AutomationFragmentation_failures, Candidate_v1.5.4, Candidate_v1.6.0, Candidate_v1.6.1, ChangeBugEmailaddress, ChangingTestPorts, ChemicalSpaceEvaluator, CombiningParticlePotentialParsing, Combining_Subpackages, Debian_Package_split, Debian_package_split_molecuildergui_only, Disabling_MemDebug, Docu_Python_wait, EmpiricalPotential_contain_HomologyGraph, EmpiricalPotential_contain_HomologyGraph_documentation, Enable_parallel_make_install, Enhance_userguide, Enhanced_StructuralOptimization, Enhanced_StructuralOptimization_continued, Example_ManyWaysToTranslateAtom, Exclude_Hydrogens_annealWithBondGraph, FitPartialCharges_GlobalError, Fix_BoundInBox_CenterInBox_MoleculeActions, Fix_ChargeSampling_PBC, Fix_ChronosMutex, Fix_FitPartialCharges, Fix_FitPotential_needs_atomicnumbers, Fix_ForceAnnealing, Fix_IndependentFragmentGrids, Fix_ParseParticles, Fix_ParseParticles_split_forward_backward_Actions, Fix_PopActions, Fix_QtFragmentList_sorted_selection, Fix_Restrictedkeyset_FragmentMolecule, Fix_StatusMsg, Fix_StepWorldTime_single_argument, Fix_Verbose_Codepatterns, Fix_fitting_potentials, Fixes, ForceAnnealing_goodresults, ForceAnnealing_oldresults, ForceAnnealing_tocheck, ForceAnnealing_with_BondGraph, ForceAnnealing_with_BondGraph_continued, ForceAnnealing_with_BondGraph_continued_betteresults, ForceAnnealing_with_BondGraph_contraction-expansion, FragmentAction_writes_AtomFragments, FragmentMolecule_checks_bonddegrees, GeometryObjects, Gui_Fixes, Gui_displays_atomic_force_velocity, ImplicitCharges, IndependentFragmentGrids, IndependentFragmentGrids_IndividualZeroInstances, IndependentFragmentGrids_IntegrationTest, IndependentFragmentGrids_Sole_NN_Calculation, JobMarket_RobustOnKillsSegFaults, JobMarket_StableWorkerPool, JobMarket_unresolvable_hostname_fix, MoreRobust_FragmentAutomation, ODR_violation_mpqc_open, PartialCharges_OrthogonalSummation, PdbParser_setsAtomName, PythonUI_with_named_parameters, QtGui_reactivate_TimeChanged_changes, Recreated_GuiChecks, Rewrite_FitPartialCharges, RotateToPrincipalAxisSystem_UndoRedo, SaturateAtoms_findBestMatching, SaturateAtoms_singleDegree, StoppableMakroAction, Subpackage_CodePatterns, Subpackage_JobMarket, Subpackage_LinearAlgebra, Subpackage_levmar, Subpackage_mpqc_open, Subpackage_vmg, Switchable_LogView, ThirdParty_MPQC_rebuilt_buildsystem, TrajectoryDependenant_MaxOrder, TremoloParser_IncreasedPrecision, TremoloParser_MultipleTimesteps, TremoloParser_setsAtomName, Ubuntu_1604_changes, stable
Children:
bbff92
Parents:
13510b (diff), 5837dd (diff)
Note: this is a merge changeset, the changes displayed below correspond to the merge itself.
Use the (diff) links above to see all the changes relative to each parent.
Message:

Merge branch 'DipoleAngularCorrelation' into mergeMaster

Conflicts:

src/World.cpp

  • tiny conflict in World.cpp
Location:
src/Analysis
Files:
2 edited

Legend:

Unmodified
Added
Removed
  • src/Analysis/analysis_correlation.cpp

    r13510b r7ba268  
    2222#include <iostream>
    2323#include <iomanip>
     24#include <limits>
    2425
    2526#include "atom.hpp"
     
    3031#include "CodePatterns/Info.hpp"
    3132#include "CodePatterns/Log.hpp"
     33#include "CodePatterns/Verbose.hpp"
     34#include "Descriptors/AtomOfMoleculeSelectionDescriptor.hpp"
     35#include "Descriptors/MoleculeFormulaDescriptor.hpp"
     36#include "Descriptors/MoleculeOfAtomSelectionDescriptor.hpp"
    3237#include "Formula.hpp"
     38#include "LinearAlgebra/Vector.hpp"
     39#include "LinearAlgebra/RealSpaceMatrix.hpp"
    3340#include "molecule.hpp"
    3441#include "Tesselation/tesselation.hpp"
     
    3643#include "Tesselation/triangleintersectionlist.hpp"
    3744#include "World.hpp"
    38 #include "LinearAlgebra/Vector.hpp"
    39 #include "LinearAlgebra/RealSpaceMatrix.hpp"
    40 #include "CodePatterns/Verbose.hpp"
    41 #include "World.hpp"
    42 #include "Box.hpp"
     45#include "WorldTime.hpp"
    4346
    4447#include "analysis_correlation.hpp"
     
    6770    // go through all bonds
    6871    const BondList& ListOfBonds = (*atomiter)->getListOfBonds();
     72    ASSERT(ListOfBonds.begin() != ListOfBonds.end(),
     73        "getDipole() - no bonds in molecule!");
    6974    for (BondList::const_iterator bonditer = ListOfBonds.begin();
    7075        bonditer != ListOfBonds.end();
     
    7883        BondDipoleVector.Normalize();
    7984        BondDipoleVector *= DeltaEN;
     85        LOG(3,"INFO: Dipole vector from bond " << **bonditer << " is " << BondDipoleVector);
    8086        DipoleVector += BondDipoleVector;
    8187        SumOfVectors++;
     
    8389    }
    8490  }
    85   DipoleVector *= 1./(double)SumOfVectors;
     91  LOG(3,"INFO: Sum over all bond dipole vectors is "
     92      << DipoleVector << " with " << SumOfVectors << " in total.");
     93  if (SumOfVectors != 0)
     94    DipoleVector *= 1./(double)SumOfVectors;
    8695  DoLog(1) && (Log() << Verbose(1) << "Resulting dipole vector is " << DipoleVector << std::endl);
    8796
     
    8998};
    9099
     100/** Calculate minimum and maximum amount of trajectory steps by going through given atomic trajectories.
     101 * \param vector of atoms whose trajectories to check for [min,max]
     102 * \return range with [min, max]
     103 */
     104range<size_t> getMaximumTrajectoryBounds(const std::vector<atom *> &atoms)
     105{
     106  // get highest trajectory size
     107  LOG(0,"STATUS: Retrieving maximum amount of time steps ...");
     108  if (atoms.size() == 0)
     109    return range<size_t>(0,0);
     110  size_t max_timesteps = std::numeric_limits<size_t>::min();
     111  size_t min_timesteps = std::numeric_limits<size_t>::max();
     112  BOOST_FOREACH(atom *_atom, atoms) {
     113    if (_atom->getTrajectorySize() > max_timesteps)
     114      max_timesteps  = _atom->getTrajectorySize();
     115    if (_atom->getTrajectorySize() < min_timesteps)
     116      min_timesteps = _atom->getTrajectorySize();
     117  }
     118  LOG(1,"INFO: Minimum number of time steps found is " << min_timesteps);
     119  LOG(1,"INFO: Maximum number of time steps found is " << max_timesteps);
     120
     121  return range<size_t>(min_timesteps, max_timesteps);
     122}
     123
     124/** Calculates the angular dipole zero orientation from current time step.
     125 * \param molecules vector of molecules to calculate dipoles of
     126 * \return map with orientation vector for each atomic id given in \a atoms.
     127 */
     128std::map<atomId_t, Vector> CalculateZeroAngularDipole(const std::vector<molecule *> &molecules)
     129{
     130  // get zero orientation for each molecule.
     131  LOG(0,"STATUS: Calculating dipoles for current time step ...");
     132  std::map<atomId_t, Vector> ZeroVector;
     133  BOOST_FOREACH(molecule *_mol, molecules) {
     134    const Vector Dipole = getDipole(_mol->begin(), _mol->end());
     135    for(molecule::const_iterator iter = _mol->begin(); iter != _mol->end(); ++iter)
     136      ZeroVector[(*iter)->getId()] = Dipole;
     137    LOG(2,"INFO: Zero alignment for molecule " << _mol->getId() << " is " << Dipole);
     138  }
     139  LOG(1,"INFO: We calculated zero orientation for a total of " << molecules.size() << " molecule(s).");
     140
     141  return ZeroVector;
     142}
     143
    91144/** Calculates the dipole angular correlation for given molecule type.
     145 * Calculate the change of the dipole orientation angle over time.
     146 * Note given element order is unimportant (i.e. g(Si, O) === g(O, Si))
     147 * Angles are given in degrees.
     148 * \param &atoms list of atoms of the molecules taking part (Note: molecules may
     149 * change over time as bond structure is recalculated, hence we need the atoms)
     150 * \param timestep time step to calculate angular correlation for (relative to
     151 *  \a ZeroVector)
     152 * \param ZeroVector map with Zero orientation vector for each atom in \a atoms.
     153 * \param DontResetTime don't reset time to old value (triggers re-creation of bond system)
     154 * \return Map of doubles with values the pair of the two atoms.
     155 */
     156DipoleAngularCorrelationMap *DipoleAngularCorrelation(
     157    const Formula &DipoleFormula,
     158    const size_t timestep,
     159    const std::map<atomId_t, Vector> &ZeroVector,
     160    const enum ResetWorldTime DoTimeReset
     161    )
     162{
     163  Info FunctionInfo(__func__);
     164  DipoleAngularCorrelationMap *outmap = new DipoleAngularCorrelationMap;
     165
     166  unsigned int oldtime = 0;
     167  if (DoTimeReset == DoResetTime) {
     168    // store original time step
     169    oldtime = WorldTime::getTime();
     170  }
     171
     172  // set time step
     173  LOG(0,"STATUS: Stepping onto to time step " << timestep << ".");
     174  World::getInstance().setTime(timestep);
     175
     176  // get all molecules for this time step
     177  World::getInstance().clearMoleculeSelection();
     178  World::getInstance().selectAllMolecules(MoleculeByFormula(DipoleFormula));
     179  std::vector<molecule *> molecules = World::getInstance().getSelectedMolecules();
     180  LOG(1,"INFO: There are " << molecules.size() << " molecules for time step " << timestep << ".");
     181
     182  // calculate dipoles for each
     183  LOG(0,"STATUS: Calculating dipoles for time step " << timestep << " ...");
     184  size_t i=0;
     185  size_t Counter_rejections = 0;
     186  BOOST_FOREACH(molecule *_mol, molecules) {
     187    const Vector Dipole = getDipole(_mol->begin(), _mol->end());
     188    LOG(3,"INFO: Dipole vector at time step " << timestep << " for for molecule "
     189        << _mol->getId() << " is " << Dipole);
     190    // check that all atoms are valid (zeroVector known)
     191    molecule::const_iterator iter = _mol->begin();
     192    for(; iter != _mol->end(); ++iter) {
     193      if (!ZeroVector.count((*iter)->getId()))
     194        break;
     195    }
     196    if (iter != _mol->end()) {
     197      ELOG(2, "Skipping molecule " << _mol->getName() << " as not all atoms have a valid zeroVector.");
     198      ++Counter_rejections;
     199      continue;
     200    } else
     201      iter = _mol->begin();
     202    std::map<atomId_t, Vector>::const_iterator zeroValue = ZeroVector.find((*iter)->getId()); //due to iter is const
     203    double angle = 0.;
     204    LOG(2, "INFO: ZeroVector of first atom " << **iter << " is "
     205        << zeroValue->second << ".");
     206    LOG(4, "INFO: Squared norm of difference vector is "
     207        << (zeroValue->second - Dipole).NormSquared() << ".");
     208    if ((zeroValue->second - Dipole).NormSquared() > MYEPSILON)
     209      angle = Dipole.Angle(zeroValue->second) * (180./M_PI);
     210    else
     211      LOG(2, "INFO: Both vectors (almost) coincide, numerically unstable, angle set to zero.");
     212    LOG(1,"INFO: Resulting relative angle for molecule " << _mol->getName()
     213        << " is " << angle << ".");
     214    outmap->insert ( make_pair (angle, *iter ) );
     215    ++i;
     216  }
     217  ASSERT(Counter_rejections <= molecules.size(),
     218      "DipoleAngularCorrelation() - more rejections ("+toString(Counter_rejections)
     219      +") than there are molecules ("+toString(molecules.size())+").");
     220  LOG(1,"INFO: " << Counter_rejections << " molecules have been rejected in time step " << timestep << ".");
     221
     222  LOG(0,"STATUS: Done with calculating dipoles.");
     223
     224  if (DoTimeReset == DoResetTime) {
     225    // re-set to original time step again
     226    World::getInstance().setTime(oldtime);
     227  }
     228
     229  // and return results
     230  return outmap;
     231};
     232
     233/** Calculates the dipole correlation for given molecule type.
     234 * I.e. we calculate how the angle between any two given dipoles in the
     235 * systems behaves. Sort of pair correlation but distance is replaced by
     236 * the orientation distance, i.e. an angle.
    92237 * Note given element order is unimportant (i.e. g(Si, O) === g(O, Si))
    93238 * Angles are given in degrees.
     
    95240 * \return Map of doubles with values the pair of the two atoms.
    96241 */
    97 DipoleAngularCorrelationMap *DipoleAngularCorrelation(std::vector<molecule *> &molecules)
     242DipoleCorrelationMap *DipoleCorrelation(std::vector<molecule *> &molecules)
    98243{
    99244  Info FunctionInfo(__func__);
    100   DipoleAngularCorrelationMap *outmap = new DipoleAngularCorrelationMap;
     245  DipoleCorrelationMap *outmap = new DipoleCorrelationMap;
    101246//  double distance = 0.;
    102247//  Box &domain = World::getInstance().getDomain();
     
    107252  }
    108253
    109   outmap = new DipoleAngularCorrelationMap;
    110254  for (std::vector<molecule *>::const_iterator MolWalker = molecules.begin();
    111255      MolWalker != molecules.end(); ++MolWalker) {
     
    168312  outmap = new PairCorrelationMap;
    169313  for (std::vector<molecule *>::const_iterator MolWalker = molecules.begin(); MolWalker != molecules.end(); MolWalker++){
    170     DoLog(2) && (Log()<< Verbose(2) << "Current molecule is " << *MolWalker << "." << endl);
     314    DoLog(2) && (Log()<< Verbose(2) << "Current molecule is " << (*MolWalker)->getName() << "." << endl);
    171315    for (molecule::const_iterator iter = (*MolWalker)->begin(); iter != (*MolWalker)->end(); ++iter) {
    172316      DoLog(3) && (Log() << Verbose(3) << "Current atom is " << **iter << "." << endl);
    173317      for (std::vector<molecule *>::const_iterator MolOtherWalker = MolWalker; MolOtherWalker != molecules.end(); MolOtherWalker++){
    174         DoLog(2) && (Log() << Verbose(2) << "Current other molecule is " << *MolOtherWalker << "." << endl);
     318        DoLog(2) && (Log() << Verbose(2) << "Current other molecule is " << (*MolOtherWalker)->getName() << "." << endl);
    175319        for (molecule::const_iterator runner = (*MolOtherWalker)->begin(); runner != (*MolOtherWalker)->end(); ++runner) {
    176320          DoLog(3) && (Log() << Verbose(3) << "Current otheratom is " << **runner << "." << endl);
     
    503647void OutputDipoleAngularCorrelation_Header( ofstream * const file )
    504648{
    505   *file << "\tAtom1\tAtom2";
    506 };
    507 
    508 /** Prints values stored in DipoleAngularCorrelationMap iterator.
     649  *file << "\tFirstAtomOfMolecule";
     650};
     651
     652/** Prints values stored in DipoleCorrelationMap iterator.
    509653 *
    510654 * @param file stream to print to
     
    512656 */
    513657void OutputDipoleAngularCorrelation_Value( ofstream * const file, DipoleAngularCorrelationMap::const_iterator &runner )
     658{
     659  *file << *(runner->second);
     660};
     661
     662
     663/** Adds header part that is unique to DipoleAngularCorrelationMap.
     664 *
     665 * @param file stream to print to
     666 */
     667void OutputDipoleCorrelation_Header( ofstream * const file )
     668{
     669  *file << "\tMolecule";
     670};
     671
     672/** Prints values stored in DipoleCorrelationMap iterator.
     673 *
     674 * @param file stream to print to
     675 * @param runner iterator pointing at values to print
     676 */
     677void OutputDipoleCorrelation_Value( ofstream * const file, DipoleCorrelationMap::const_iterator &runner )
    514678{
    515679  *file << runner->second.first->getId() << "\t" << runner->second.second->getId();
  • src/Analysis/analysis_correlation.hpp

    r13510b r7ba268  
    3131#include "CodePatterns/Info.hpp"
    3232#include "CodePatterns/Log.hpp"
     33#include "CodePatterns/Range.hpp"
    3334#include "CodePatterns/Verbose.hpp"
    3435#include "Helpers/helpers.hpp"
     
    4647
    4748typedef multimap<double, pair<atom *, atom *> > PairCorrelationMap;
    48 typedef multimap<double, pair<molecule *, molecule *> > DipoleAngularCorrelationMap;
     49typedef multimap<double, atom * > DipoleAngularCorrelationMap;
     50typedef multimap<double, pair<molecule *, molecule *> > DipoleCorrelationMap;
    4951typedef multimap<double, pair<atom *, const Vector *> > CorrelationToPointMap;
    5052typedef multimap<double, pair<atom *, BoundaryTriangleSet *> > CorrelationToSurfaceMap;
    5153typedef map<double, int> BinPairMap;
    5254
     55enum ResetWorldTime {
     56  DontResetTime,
     57  DoResetTime
     58};
     59
    5360/********************************************** declarations *******************************/
    5461
    55 DipoleAngularCorrelationMap *DipoleAngularCorrelation(std::vector<molecule *> &molecules);
     62range<size_t> getMaximumTrajectoryBounds(const std::vector<atom *> &atoms);
     63std::map<atomId_t, Vector> CalculateZeroAngularDipole(const std::vector<molecule *> &molecules);
     64
     65DipoleAngularCorrelationMap *DipoleAngularCorrelation(const Formula &DipoleFormula, const size_t timestep, const std::map<atomId_t, Vector> &ZeroVector, const enum ResetWorldTime DoTimeReset = DontResetTime);
     66DipoleCorrelationMap *DipoleCorrelation(std::vector<molecule *> &molecules);
    5667PairCorrelationMap *PairCorrelation(std::vector<molecule *> &molecules, const std::vector<const element *> &elements);
    5768CorrelationToPointMap *CorrelationToPoint(std::vector<molecule *> &molecules, const std::vector<const element *> &elements, const Vector *point );
     
    6576void OutputDipoleAngularCorrelation_Header( ofstream * const file );
    6677void OutputDipoleAngularCorrelation_Value( ofstream * const file, DipoleAngularCorrelationMap::const_iterator &runner );
     78void OutputDipoleCorrelation_Header( ofstream * const file );
     79void OutputDipoleCorrelation_Value( ofstream * const file, DipoleCorrelationMap::const_iterator &runner );
    6780void OutputPairCorrelation_Header( ofstream * const file );
    6881void OutputPairCorrelation_Value( ofstream * const file, PairCorrelationMap::const_iterator &runner );
Note: See TracChangeset for help on using the changeset viewer.