/* * ForceAnnealing.hpp * * Created on: Aug 02, 2014 * Author: heber */ #ifndef FORCEANNEALING_HPP_ #define FORCEANNEALING_HPP_ // include config.h #ifdef HAVE_CONFIG_H #include #endif #include "Atom/atom.hpp" #include "Atom/AtomSet.hpp" #include "CodePatterns/Assert.hpp" #include "CodePatterns/Info.hpp" #include "CodePatterns/Log.hpp" #include "CodePatterns/Verbose.hpp" #include "Descriptors/AtomIdDescriptor.hpp" #include "Dynamics/AtomicForceManipulator.hpp" #include "Fragmentation/ForceMatrix.hpp" #include "Graph/BoostGraphCreator.hpp" #include "Graph/BoostGraphHelpers.hpp" #include "Graph/BreadthFirstSearchGatherer.hpp" #include "Helpers/helpers.hpp" #include "Helpers/defs.hpp" #include "LinearAlgebra/LinearSystemOfEquations.hpp" #include "LinearAlgebra/MatrixContent.hpp" #include "LinearAlgebra/Vector.hpp" #include "LinearAlgebra/VectorContent.hpp" #include "Thermostats/ThermoStatContainer.hpp" #include "Thermostats/Thermostat.hpp" #include "World.hpp" /** This class is the essential build block for performing structural optimization. * * Sadly, we have to use some static instances as so far values cannot be passed * between actions. Hence, we need to store the current step and the adaptive- * step width (we cannot perform a line search, as we have no control over the * calculation of the forces). * * However, we do use the bond graph, i.e. if a single atom needs to be shifted * to the left, then the whole molecule left of it is shifted, too. This is * controlled by the \a max_distance parameter. */ template class ForceAnnealing : public AtomicForceManipulator { public: /** Constructor of class ForceAnnealing. * * \note We use a fixed delta t of 1. * * \param _atoms set of atoms to integrate * \param _Deltat time step width in atomic units * \param _IsAngstroem whether length units are in angstroem or bohr radii * \param _maxSteps number of optimization steps to perform * \param _max_distance up to this bond order is bond graph taken into account. */ ForceAnnealing( AtomSetMixin &_atoms, const double _Deltat, bool _IsAngstroem, const size_t _maxSteps, const int _max_distance, const double _damping_factor) : AtomicForceManipulator(_atoms, _Deltat, _IsAngstroem), maxSteps(_maxSteps), max_distance(_max_distance), damping_factor(_damping_factor) {} /** Destructor of class ForceAnnealing. * */ ~ForceAnnealing() {} /** Performs Gradient optimization. * * We assume that forces have just been calculated. * * * \param CurrentTimeStep current time step (i.e. \f$ t + \Delta t \f$ in the sense of the velocity verlet) * \param offset offset in matrix file to the first force component * \todo This is not yet checked if it is correctly working with DoConstrainedMD set >0. */ void operator()( const int _CurrentTimeStep, const size_t _offset, const bool _UseBondgraph) { // make sum of forces equal zero AtomicForceManipulator::correctForceMatrixForFixedCenterOfMass(_offset, _CurrentTimeStep); // are we in initial step? Then set static entities Vector maxComponents(zeroVec); if (currentStep == 0) { currentDeltat = AtomicForceManipulator::Deltat; currentStep = 1; LOG(2, "DEBUG: Initial step, setting values, current step is #" << currentStep); // always use atomic annealing on first step anneal(_CurrentTimeStep, _offset, maxComponents); } else { ++currentStep; LOG(2, "DEBUG: current step is #" << currentStep); if (_UseBondgraph) annealWithBondGraph(_CurrentTimeStep, _offset, maxComponents); else anneal(_CurrentTimeStep, _offset, maxComponents); } LOG(1, "STATUS: Largest remaining force components at step #" << currentStep << " are " << maxComponents); // are we in final step? Remember to reset static entities if (currentStep == maxSteps) { LOG(2, "DEBUG: Final step, resetting values"); reset(); } } /** Helper function to calculate the Barzilai-Borwein stepwidth. * * \param _PositionDifference difference in position between current and last step * \param _GradientDifference difference in gradient between current and last step * \return step width according to Barzilai-Borwein */ double getBarzilaiBorweinStepwidth(const Vector &_PositionDifference, const Vector &_GradientDifference) { double stepwidth = 0.; if (_GradientDifference.NormSquared() > MYEPSILON) stepwidth = fabs(_PositionDifference.ScalarProduct(_GradientDifference))/ _GradientDifference.NormSquared(); if (fabs(stepwidth) < 1e-10) { // dont' warn in first step, deltat usage normal if (currentStep != 1) ELOG(1, "INFO: Barzilai-Borwein stepwidth is zero, using deltat " << currentDeltat << " instead."); stepwidth = currentDeltat; } return stepwidth; } /** Performs Gradient optimization on the atoms. * * We assume that forces have just been calculated. * * \param CurrentTimeStep current time step (i.e. \f$ t + \Delta t \f$ in the sense of the velocity verlet) * \param offset offset in matrix file to the first force component * \param maxComponents to be filled with maximum force component over all atoms */ void anneal( const int CurrentTimeStep, const size_t offset, Vector &maxComponents) { for(typename AtomSetMixin::iterator iter = AtomicForceManipulator::atoms.begin(); iter != AtomicForceManipulator::atoms.end(); ++iter) { // atom's force vector gives steepest descent direction const Vector oldPosition = (*iter)->getPositionAtStep(CurrentTimeStep-1 >= 0 ? CurrentTimeStep - 1 : 0); const Vector currentPosition = (*iter)->getPositionAtStep(CurrentTimeStep); const Vector oldGradient = (*iter)->getAtomicForceAtStep(CurrentTimeStep-1 >= 0 ? CurrentTimeStep - 1 : 0); const Vector currentGradient = (*iter)->getAtomicForceAtStep(CurrentTimeStep); LOG(4, "DEBUG: oldPosition for atom " << **iter << " is " << oldPosition); LOG(4, "DEBUG: currentPosition for atom " << **iter << " is " << currentPosition); LOG(4, "DEBUG: oldGradient for atom " << **iter << " is " << oldGradient); LOG(4, "DEBUG: currentGradient for atom " << **iter << " is " << currentGradient); // LOG(4, "DEBUG: Force for atom " << **iter << " is " << currentGradient); // we use Barzilai-Borwein update with position reversed to get descent const double stepwidth = getBarzilaiBorweinStepwidth( currentPosition - oldPosition, currentGradient - oldGradient); Vector PositionUpdate = stepwidth * currentGradient; LOG(3, "DEBUG: Update would be " << stepwidth << "*" << currentGradient << " = " << PositionUpdate); // extract largest components for showing progress of annealing for(size_t i=0;i 1) && (!(*iter)->getAtomicVelocity().IsZero())) // update with currentDelta tells us how the current gradient relates to // the last one: If it has become larger, reduce currentDelta if ((PositionUpdate.ScalarProduct((*iter)->getAtomicVelocity()) < 0) && (currentDeltat > MinimumDeltat)) { currentDeltat = .5*currentDeltat; LOG(2, "DEBUG: Upgrade in other direction: " << PositionUpdate.NormSquared() << " > " << (*iter)->getAtomicVelocity().NormSquared() << ", decreasing deltat: " << currentDeltat); PositionUpdate = currentDeltat * currentGradient; } // finally set new values (*iter)->setPosition(currentPosition + PositionUpdate); (*iter)->setAtomicVelocity(PositionUpdate); //std::cout << "Id of atom is " << (*iter)->getId() << std::endl; // (*iter)->VelocityVerletUpdateU((*iter)->getId(), CurrentTimeStep-1, Deltat, IsAngstroem); } } /** Performs Gradient optimization on the bonds. * * We assume that forces have just been calculated. These forces are projected * onto the bonds and these are annealed subsequently by moving atoms in the * bond neighborhood on either side conjunctively. * * * \param CurrentTimeStep current time step (i.e. t where \f$ t + \Delta t \f$ is in the sense of the velocity verlet) * \param offset offset in matrix file to the first force component * \param maxComponents to be filled with maximum force component over all atoms */ void annealWithBondGraph( const int CurrentTimeStep, const size_t offset, Vector &maxComponents) { // get nodes on either side of selected bond via BFS discovery // std::vector atomids; // for(typename AtomSetMixin::iterator iter = AtomicForceManipulator::atoms.begin(); // iter != AtomicForceManipulator::atoms.end(); ++iter) { // atomids.push_back((*iter)->getId()); // } // ASSERT( atomids.size() == AtomicForceManipulator::atoms.size(), // "ForceAnnealing() - could not gather all atomic ids?"); BoostGraphCreator BGcreator; BGcreator.createFromRange( AtomicForceManipulator::atoms.begin(), AtomicForceManipulator::atoms.end(), AtomicForceManipulator::atoms.size(), BreadthFirstSearchGatherer::AlwaysTruePredicate); BreadthFirstSearchGatherer NodeGatherer(BGcreator); /// We assume that a force is local, i.e. a bond is too short yet and hence /// the atom needs to be moved. However, all the adjacent (bound) atoms might /// already be at the perfect distance. If we just move the atom alone, we ruin /// all the other bonds. Hence, it would be sensible to move every atom found /// through the bond graph in the direction of the force as well by the same /// PositionUpdate. This is almost what we are going to do. /// One more issue is: If we need to shorten bond, then we use the PositionUpdate /// also on the the other bond partner already. This is because it is in the /// direction of the bond. Therefore, the update is actually performed twice on /// each bond partner, i.e. the step size is twice as large as it should be. /// This problem only occurs when bonds need to be shortened, not when they /// need to be made longer (then the force vector is facing the other /// direction than the bond vector). /// As a remedy we need to know the forces "per bond" and not per atom. /// In effect, the gradient is the error per atom. However, we need an /// error per bond. To this end, we set up a matrix A that translate the /// vector of bond energies into a vector of atomic force component and /// then we simply solve the linear system (inverse problem) via an SVD /// and use the bond gradients to get the PositionUpdate for both bond /// partners at the same time when we go through all bonds. // gather/enumerate all bonds std::set allbonds; std::vector allatomids; for(typename AtomSetMixin::iterator iter = AtomicForceManipulator::atoms.begin(); iter != AtomicForceManipulator::atoms.end(); ++iter) { const atom &walker = *(*iter); allatomids.push_back(walker.getId()); const BondList& ListOfBonds = walker.getListOfBonds(); for(BondList::const_iterator bonditer = ListOfBonds.begin(); bonditer != ListOfBonds.end(); ++bonditer) { const bond::ptr ¤t_bond = *bonditer; allbonds.insert(current_bond); } // extract largest components for showing progress of annealing const Vector currentGradient = (*iter)->getAtomicForce(); for(size_t i=0;isetAtomicForce(zeroVec); } std::sort(allatomids.begin(), allatomids.end()); // converting set back to vector is fastest when requiring sorted and unique, // see https://stackoverflow.com/questions/1041620/whats-the-most-efficient-way-to-erase-duplicates-and-sort-a-vector typedef std::vector bondvector_t; bondvector_t bondvector( allbonds.begin(), allbonds.end() ); // setup matrix A given the enumerated bonds LinearSystemOfEquations lseq(AtomicForceManipulator::atoms.size(), bondvector.size()); for (size_t i = 0;ileftatom, bondvector[i]->rightatom }; size_t index[2]; for (size_t n=0;n<2;++n) { const std::pair::iterator, std::vector::iterator> atomiditer = std::equal_range(allatomids.begin(), allatomids.end(), bondatom[n]->getId()); index[n] = std::distance(allatomids.begin(), atomiditer.first); (*lseq.A).at(index[0],index[1]) = 1.; (*lseq.A).at(index[1],index[0]) = 1.; } } lseq.SetSymmetric(true); // for each component and for current and last time step // solve Ax=y with given A and y being the vectorized atomic force double *tmpforces = new double[bondvector.size()]; double *bondforces = new double[bondvector.size()]; double *oldbondforces = new double[bondvector.size()]; double *bondforceref[2] = { bondforces, oldbondforces }; for (size_t n=0;n::iterator iter = AtomicForceManipulator::atoms.begin(); iter != AtomicForceManipulator::atoms.end(); ++iter) { const atom &walker = *(*iter); const std::pair::iterator, std::vector::iterator> atomiditer = std::equal_range(allatomids.begin(), allatomids.end(), walker.getId()); const size_t i = std::distance(allatomids.begin(), atomiditer.first); (*lseq.b).at(i) = timestep == 0 ? walker.getAtomicForce()[component] : walker.getAtomicForceAtStep(CurrentTimeStep-2 >= 0 ? CurrentTimeStep - 2 : 0)[component]; } lseq.GetSolutionAsArray(tmpforces); for (size_t i = 0;i GatheredUpdates; //!< gathers all updates which are applied at the end for (size_t i = 0;ileftatom, bondvector[i]->rightatom}; const double &bondforce = bondforces[i]; const double &oldbondforce = oldbondforces[i]; const double bondforcedifference = (bondforce - oldbondforce); Vector BondVector = (bondatom[0]->getPosition() - bondatom[1]->getPosition()); BondVector.Normalize(); double stepwidth = 0.; for (size_t n=0;n<2;++n) { const Vector oldPosition = bondatom[n]->getPositionAtStep(CurrentTimeStep-2 >= 0 ? CurrentTimeStep - 2 : 0); const Vector currentPosition = bondatom[n]->getPosition(); stepwidth += fabs((currentPosition - oldPosition).ScalarProduct(BondVector))/bondforcedifference; } stepwidth = stepwidth/2; Vector PositionUpdate = stepwidth * BondVector; if (fabs(stepwidth) < 1e-10) { // dont' warn in first step, deltat usage normal if (currentStep != 1) ELOG(1, "INFO: Barzilai-Borwein stepwidth is zero, using deltat " << currentDeltat << " instead."); PositionUpdate = currentDeltat * BondVector; } LOG(3, "DEBUG: Update would be " << PositionUpdate); // remove the edge #ifndef NDEBUG const bool status = #endif BGcreator.removeEdge(bondatom[0]->getId(), bondatom[1]->getId()); ASSERT( status, "ForceAnnealing() - edge to found bond is not present?"); // gather nodes for either atom BoostGraphHelpers::Nodeset_t bondside_set[2]; BreadthFirstSearchGatherer::distance_map_t distance_map[2]; for (size_t n=0;n<2;++n) { bondside_set[n] = NodeGatherer(bondatom[n]->getId(), max_distance); distance_map[n] = NodeGatherer.getDistances(); std::sort(bondside_set[n].begin(), bondside_set[n].end()); } // re-add edge BGcreator.addEdge(bondatom[0]->getId(), bondatom[1]->getId()); // add PositionUpdate for all nodes in the bondside_set for (size_t n=0;n<2;++n) { for (BoostGraphHelpers::Nodeset_t::const_iterator setiter = bondside_set[n].begin(); setiter != bondside_set[n].end(); ++setiter) { const BreadthFirstSearchGatherer::distance_map_t::const_iterator diter = distance_map[n].find(*setiter); ASSERT( diter != distance_map[n].end(), "ForceAnnealing() - could not find distance to an atom."); const double factor = pow(damping_factor, diter->second); LOG(3, "DEBUG: Update for atom #" << *setiter << " will be " << factor << "*" << PositionUpdate); if (GatheredUpdates.count((*setiter))) { GatheredUpdates[(*setiter)] += factor*PositionUpdate; } else { GatheredUpdates.insert( std::make_pair( (*setiter), factor*PositionUpdate) ); } } // invert for other atom PositionUpdate *= -1; } } // apply the gathered updates for (std::map::const_iterator iter = GatheredUpdates.begin(); iter != GatheredUpdates.end(); ++iter) { const atomId_t &atomid = iter->first; const Vector &update = iter->second; atom* const walker = World::getInstance().getAtom(AtomById(atomid)); ASSERT( walker != NULL, "ForceAnnealing() - walker with id "+toString(atomid)+" has suddenly disappeared."); LOG(3, "DEBUG: Applying update " << update << " to atom #" << atomid << ", namely " << *walker); walker->setPosition( walker->getPosition() + update ); } } /** Reset function to unset static entities and artificial velocities. * */ void reset() { currentDeltat = 0.; currentStep = 0; } private: //!> contains the current step in relation to maxsteps static size_t currentStep; //!> contains the maximum number of steps, determines initial and final step with currentStep size_t maxSteps; static double currentDeltat; //!> minimum deltat for internal while loop (adaptive step width) static double MinimumDeltat; //!> contains the maximum bond graph distance up to which shifts of a single atom are spread const int max_distance; //!> the shifted is dampened by this factor with the power of the bond graph distance to the shift causing atom const double damping_factor; }; template double ForceAnnealing::currentDeltat = 0.; template size_t ForceAnnealing::currentStep = 0; template double ForceAnnealing::MinimumDeltat = 1e-8; #endif /* FORCEANNEALING_HPP_ */