source: src/Tesselation/boundary.cpp@ 691318

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 Candidate_v1.7.0 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
Last change on this file since 691318 was 7d82a5, checked in by Frederik Heber <heber@…>, 13 years ago

Changed bond::ptr into boost::shared_ptr.

Changes:

  • refactored some BondedParticle functions, cleaning up the interface in terms of private and public functionality, added some helper functions to find bonds.
  • ptr = NULL --> .reset().
  • now initialising to NULL.
  • BondsPerSP is now list of boost::shared_ptr as well.
  • some include of bond.hpp instead of forward references necessary.
  • leftatom and rightatom are now set to NULL on UnregisterBond().
  • bonds are not deleted anymore but simply unregistered.
  • FIX: BondedParticleInfo did unrequiredly inherit AtomObservable.
  • removed UnregisterAllBonds(), code is now in RemoveAllBonds() where UnregisterBond is called for both bond partners. This ensures that the bond is correctly released and shared_ptr free'd.
  • Property mode set to 100644
File size: 68.0 KB
RevLine 
[bcf653]1/*
2 * Project: MoleCuilder
3 * Description: creates and alters molecular systems
[0aa122]4 * Copyright (C) 2010-2012 University of Bonn. All rights reserved.
[94d5ac6]5 *
6 *
7 * This file is part of MoleCuilder.
8 *
9 * MoleCuilder is free software: you can redistribute it and/or modify
10 * it under the terms of the GNU General Public License as published by
11 * the Free Software Foundation, either version 2 of the License, or
12 * (at your option) any later version.
13 *
14 * MoleCuilder is distributed in the hope that it will be useful,
15 * but WITHOUT ANY WARRANTY; without even the implied warranty of
16 * MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the
17 * GNU General Public License for more details.
18 *
19 * You should have received a copy of the GNU General Public License
20 * along with MoleCuilder. If not, see <http://www.gnu.org/licenses/>.
[bcf653]21 */
22
[f66195]23/** \file boundary.cpp
[edb93c]24 *
25 * Implementations and super-function for envelopes
[2319ed]26 */
27
[bf3817]28// include config.h
29#ifdef HAVE_CONFIG_H
30#include <config.h>
31#endif
32
[ad011c]33#include "CodePatterns/MemDebug.hpp"
[112b09]34
[6f0841]35#include "Atom/atom.hpp"
[129204]36#include "Bond/bond.hpp"
[8eb17a]37#include "boundary.hpp"
[34c43a]38#include "BoundaryLineSet.hpp"
39#include "BoundaryPointSet.hpp"
40#include "BoundaryTriangleSet.hpp"
41#include "Box.hpp"
42#include "CandidateForTesselation.hpp"
43#include "CodePatterns/Info.hpp"
44#include "CodePatterns/Log.hpp"
45#include "CodePatterns/Verbose.hpp"
[f66195]46#include "config.hpp"
[3bdb6d]47#include "Element/element.hpp"
[34c43a]48#include "LinearAlgebra/Plane.hpp"
49#include "LinearAlgebra/RealSpaceMatrix.hpp"
[53c7fc]50#include "LinkedCell/linkedcell.hpp"
51#include "LinkedCell/PointCloudAdaptor.hpp"
[f66195]52#include "molecule.hpp"
[42127c]53#include "MoleculeListClass.hpp"
[34c43a]54#include "RandomNumbers/RandomNumberGeneratorFactory.hpp"
55#include "RandomNumbers/RandomNumberGenerator.hpp"
[f66195]56#include "tesselation.hpp"
57#include "tesselationhelpers.hpp"
[b34306]58#include "World.hpp"
[2319ed]59
[986ed3]60#include <iostream>
[36166d]61#include <iomanip>
62
[357fba]63#include<gsl/gsl_poly.h>
[d6eb80]64#include<time.h>
[2319ed]65
[357fba]66// ========================================== F U N C T I O N S =================================
[2319ed]67
68
[357fba]69/** Determines greatest diameters of a cluster defined by its convex envelope.
70 * Looks at lines parallel to one axis and where they intersect on the projected planes
[2319ed]71 * \param *out output stream for debugging
[357fba]72 * \param *BoundaryPoints NDIM set of boundary points defining the convex envelope on each projected plane
73 * \param *mol molecule structure representing the cluster
[776b64]74 * \param *&TesselStruct Tesselation structure with triangles
[357fba]75 * \param IsAngstroem whether we have angstroem or atomic units
76 * \return NDIM array of the diameters
[e4ea46]77 */
[e138de]78double *GetDiametersOfCluster(const Boundaries *BoundaryPtr, const molecule *mol, Tesselation *&TesselStruct, const bool IsAngstroem)
[caf5d6]79{
[ce7bfd]80 //Info FunctionInfo(__func__);
[357fba]81 // get points on boundary of NULL was given as parameter
82 bool BoundaryFreeFlag = false;
[ad37ab]83 double OldComponent = 0.;
84 double tmp = 0.;
85 double w1 = 0.;
86 double w2 = 0.;
87 Vector DistanceVector;
88 Vector OtherVector;
89 int component = 0;
90 int Othercomponent = 0;
[776b64]91 Boundaries::const_iterator Neighbour;
92 Boundaries::const_iterator OtherNeighbour;
[ad37ab]93 double *GreatestDiameter = new double[NDIM];
94
[776b64]95 const Boundaries *BoundaryPoints;
96 if (BoundaryPtr == NULL) {
[357fba]97 BoundaryFreeFlag = true;
[e138de]98 BoundaryPoints = GetBoundaryPoints(mol, TesselStruct);
[86234b]99 } else {
[776b64]100 BoundaryPoints = BoundaryPtr;
[47d041]101 LOG(0, "Using given boundary points set.");
[86234b]102 }
[357fba]103 // determine biggest "diameter" of cluster for each axis
104 for (int i = 0; i < NDIM; i++)
105 GreatestDiameter[i] = 0.;
106 for (int axis = 0; axis < NDIM; axis++)
107 { // regard each projected plane
[47d041]108 //LOG(1, "Current axis is " << axis << ".");
[357fba]109 for (int j = 0; j < 2; j++)
110 { // and for both axis on the current plane
111 component = (axis + j + 1) % NDIM;
112 Othercomponent = (axis + 1 + ((j + 1) & 1)) % NDIM;
[47d041]113 //LOG(1, "Current component is " << component << ", Othercomponent is " << Othercomponent << ".");
[776b64]114 for (Boundaries::const_iterator runner = BoundaryPoints[axis].begin(); runner != BoundaryPoints[axis].end(); runner++) {
[47d041]115 //LOG(1, "Current runner is " << *(runner->second.second) << ".");
[357fba]116 // seek for the neighbours pair where the Othercomponent sign flips
117 Neighbour = runner;
118 Neighbour++;
119 if (Neighbour == BoundaryPoints[axis].end()) // make it wrap around
120 Neighbour = BoundaryPoints[axis].begin();
[d74077]121 DistanceVector = (runner->second.second->getPosition()) - (Neighbour->second.second->getPosition());
[776b64]122 do { // seek for neighbour pair where it flips
[0a4f7f]123 OldComponent = DistanceVector[Othercomponent];
[357fba]124 Neighbour++;
125 if (Neighbour == BoundaryPoints[axis].end()) // make it wrap around
126 Neighbour = BoundaryPoints[axis].begin();
[d74077]127 DistanceVector = (runner->second.second->getPosition()) - (Neighbour->second.second->getPosition());
[47d041]128 //LOG(2, "OldComponent is " << OldComponent << ", new one is " << DistanceVector.x[Othercomponent] << ".");
[776b64]129 } while ((runner != Neighbour) && (fabs(OldComponent / fabs(
[0a4f7f]130 OldComponent) - DistanceVector[Othercomponent] / fabs(
131 DistanceVector[Othercomponent])) < MYEPSILON)); // as long as sign does not flip
[776b64]132 if (runner != Neighbour) {
[357fba]133 OtherNeighbour = Neighbour;
134 if (OtherNeighbour == BoundaryPoints[axis].begin()) // make it wrap around
135 OtherNeighbour = BoundaryPoints[axis].end();
136 OtherNeighbour--;
[47d041]137 //LOG(1, "The pair, where the sign of OtherComponent flips, is: " << *(Neighbour->second.second) << " and " << *(OtherNeighbour->second.second) << ".");
[357fba]138 // now we have found the pair: Neighbour and OtherNeighbour
[d74077]139 OtherVector = (runner->second.second->getPosition()) - (OtherNeighbour->second.second->getPosition());
[47d041]140 //LOG(1, "Distances to Neighbour and OtherNeighbour are " << DistanceVector.x[component] << " and " << OtherVector.x[component] << ".");
141 //LOG(1, "OtherComponents to Neighbour and OtherNeighbour are " << DistanceVector.x[Othercomponent] << " and " << OtherVector.x[Othercomponent] << ".");
[357fba]142 // do linear interpolation between points (is exact) to extract exact intersection between Neighbour and OtherNeighbour
[0a4f7f]143 w1 = fabs(OtherVector[Othercomponent]);
144 w2 = fabs(DistanceVector[Othercomponent]);
145 tmp = fabs((w1 * DistanceVector[component] + w2
146 * OtherVector[component]) / (w1 + w2));
[357fba]147 // mark if it has greater diameter
[47d041]148 //LOG(1, "Comparing current greatest " << GreatestDiameter[component] << " to new " << tmp << ".");
[357fba]149 GreatestDiameter[component] = (GreatestDiameter[component]
150 > tmp) ? GreatestDiameter[component] : tmp;
151 } //else
[47d041]152 //LOG(1, "Saw no sign flip, probably top or bottom node.");
[3d919e]153 }
154 }
155 }
[47d041]156 LOG(0, "RESULT: The biggest diameters are "
[357fba]157 << GreatestDiameter[0] << " and " << GreatestDiameter[1] << " and "
158 << GreatestDiameter[2] << " " << (IsAngstroem ? "angstrom"
[47d041]159 : "atomiclength") << ".");
[03648b]160
[357fba]161 // free reference lists
162 if (BoundaryFreeFlag)
163 delete[] (BoundaryPoints);
[e4ea46]164
[357fba]165 return GreatestDiameter;
[e4ea46]166}
167;
[03648b]168
[042f82]169
[357fba]170/** Determines the boundary points of a cluster.
171 * Does a projection per axis onto the orthogonal plane, transforms into spherical coordinates, sorts them by the angle
172 * and looks at triples: if the middle has less a distance than the allowed maximum height of the triangle formed by the plane's
173 * center and first and last point in the triple, it is thrown out.
174 * \param *out output stream for debugging
175 * \param *mol molecule structure representing the cluster
[776b64]176 * \param *&TesselStruct pointer to Tesselation structure
[e4ea46]177 */
[e138de]178Boundaries *GetBoundaryPoints(const molecule *mol, Tesselation *&TesselStruct)
[caf5d6]179{
[ce7bfd]180 //Info FunctionInfo(__func__);
[357fba]181 PointMap PointsOnBoundary;
182 LineMap LinesOnBoundary;
183 TriangleMap TrianglesOnBoundary;
[e138de]184 Vector *MolCenter = mol->DetermineCenterOfAll();
[357fba]185 Vector helper;
[ad37ab]186 BoundariesTestPair BoundaryTestPair;
187 Vector AxisVector;
188 Vector AngleReferenceVector;
189 Vector AngleReferenceNormalVector;
190 Vector ProjectedVector;
[5309ba]191 Boundaries *BoundaryPoints = new Boundaries[NDIM]; // first is alpha, second is (r, Nr)
[ad37ab]192 double angle = 0.;
[042f82]193
[357fba]194 // 3a. Go through every axis
195 for (int axis = 0; axis < NDIM; axis++) {
196 AxisVector.Zero();
197 AngleReferenceVector.Zero();
198 AngleReferenceNormalVector.Zero();
[0a4f7f]199 AxisVector[axis] = 1.;
200 AngleReferenceVector[(axis + 1) % NDIM] = 1.;
201 AngleReferenceNormalVector[(axis + 2) % NDIM] = 1.;
[042f82]202
[47d041]203 LOG(1, "Axisvector is " << AxisVector << " and AngleReferenceVector is " << AngleReferenceVector << ", and AngleReferenceNormalVector is " << AngleReferenceNormalVector << ".");
[042f82]204
[357fba]205 // 3b. construct set of all points, transformed into cylindrical system and with left and right neighbours
[59fff1]206 // Boundaries stores non-const TesselPoint ref, hence we need iterator here
207 for (molecule::iterator iter = mol->begin(); iter != mol->end(); ++iter) {
[d74077]208 ProjectedVector = (*iter)->getPosition() - (*MolCenter);
[273382]209 ProjectedVector.ProjectOntoPlane(AxisVector);
[042f82]210
[357fba]211 // correct for negative side
[776b64]212 const double radius = ProjectedVector.NormSquared();
[357fba]213 if (fabs(radius) > MYEPSILON)
[273382]214 angle = ProjectedVector.Angle(AngleReferenceVector);
[357fba]215 else
216 angle = 0.; // otherwise it's a vector in Axis Direction and unimportant for boundary issues
[042f82]217
[47d041]218 //LOG(1, "Checking sign in quadrant : " << ProjectedVector.Projection(&AngleReferenceNormalVector) << ".");
[273382]219 if (ProjectedVector.ScalarProduct(AngleReferenceNormalVector) > 0) {
[357fba]220 angle = 2. * M_PI - angle;
221 }
[47d041]222 LOG(1, "Inserting " << **iter << ": (r, alpha) = (" << radius << "," << angle << "): " << ProjectedVector);
[6b5657]223 BoundaryTestPair = BoundaryPoints[axis].insert(BoundariesPair(angle, TesselPointDistancePair (radius, (*iter))));
[357fba]224 if (!BoundaryTestPair.second) { // same point exists, check first r, then distance of original vectors to center of gravity
[47d041]225 LOG(2, "Encountered two vectors whose projection onto axis " << axis << " is equal: ");
226 LOG(2, "Present vector: " << *BoundaryTestPair.first->second.second);
227 LOG(2, "New vector: " << **iter);
[776b64]228 const double ProjectedVectorNorm = ProjectedVector.NormSquared();
229 if ((ProjectedVectorNorm - BoundaryTestPair.first->second.first) > MYEPSILON) {
230 BoundaryTestPair.first->second.first = ProjectedVectorNorm;
[9879f6]231 BoundaryTestPair.first->second.second = (*iter);
[47d041]232 LOG(2, "Keeping new vector due to larger projected distance " << ProjectedVectorNorm << ".");
[776b64]233 } else if (fabs(ProjectedVectorNorm - BoundaryTestPair.first->second.first) < MYEPSILON) {
[d74077]234 helper = (*iter)->getPosition() - (*MolCenter);
[776b64]235 const double oldhelperNorm = helper.NormSquared();
[d74077]236 helper = BoundaryTestPair.first->second.second->getPosition() - (*MolCenter);
[776b64]237 if (helper.NormSquared() < oldhelperNorm) {
[9879f6]238 BoundaryTestPair.first->second.second = (*iter);
[47d041]239 LOG(2, "Keeping new vector due to larger distance to molecule center " << helper.NormSquared() << ".");
[357fba]240 } else {
[47d041]241 LOG(2, "Keeping present vector due to larger distance to molecule center " << oldhelperNorm << ".");
[357fba]242 }
243 } else {
[47d041]244 LOG(2, "Keeping present vector due to larger projected distance " << ProjectedVectorNorm << ".");
[357fba]245 }
[018741]246 }
[3d919e]247 }
[357fba]248 // printing all inserted for debugging
249 // {
[47d041]250 // std::stringstream output;
251 // output << "Printing list of candidates for axis " << axis << " which we have inserted so far: ";
[357fba]252 // int i=0;
253 // for(Boundaries::iterator runner = BoundaryPoints[axis].begin(); runner != BoundaryPoints[axis].end(); runner++) {
254 // if (runner != BoundaryPoints[axis].begin())
[47d041]255 // output << ", " << i << ": " << *runner->second.second;
[357fba]256 // else
[47d041]257 // output << i << ": " << *runner->second.second;
[357fba]258 // i++;
259 // }
[47d041]260 // LOG(1, output.str());
[357fba]261 // }
262 // 3c. throw out points whose distance is less than the mean of left and right neighbours
263 bool flag = false;
[47d041]264 LOG(1, "Looking for candidates to kick out by convex condition ... ");
[357fba]265 do { // do as long as we still throw one out per round
266 flag = false;
[accebe]267 Boundaries::iterator left = BoundaryPoints[axis].begin();
268 Boundaries::iterator right = BoundaryPoints[axis].begin();
269 Boundaries::iterator runner = BoundaryPoints[axis].begin();
270 bool LoopOnceDone = false;
271 while (!LoopOnceDone) {
272 runner = right;
273 right++;
[357fba]274 // set neighbours correctly
275 if (runner == BoundaryPoints[axis].begin()) {
276 left = BoundaryPoints[axis].end();
277 } else {
278 left = runner;
279 }
280 left--;
281 if (right == BoundaryPoints[axis].end()) {
282 right = BoundaryPoints[axis].begin();
[accebe]283 LoopOnceDone = true;
[357fba]284 }
285 // check distance
[3d919e]286
[357fba]287 // construct the vector of each side of the triangle on the projected plane (defined by normal vector AxisVector)
288 {
289 Vector SideA, SideB, SideC, SideH;
[d74077]290 SideA = left->second.second->getPosition() - (*MolCenter);
[273382]291 SideA.ProjectOntoPlane(AxisVector);
[47d041]292 // LOG(1, "SideA: " << SideA);
[3d919e]293
[d74077]294 SideB = right->second.second->getPosition() -(*MolCenter);
[273382]295 SideB.ProjectOntoPlane(AxisVector);
[47d041]296 // LOG(1, "SideB: " << SideB);
[3d919e]297
[d74077]298 SideC = left->second.second->getPosition() - right->second.second->getPosition();
[273382]299 SideC.ProjectOntoPlane(AxisVector);
[47d041]300 // LOG(1, "SideC: " << SideC);
[3d919e]301
[d74077]302 SideH = runner->second.second->getPosition() -(*MolCenter);
[273382]303 SideH.ProjectOntoPlane(AxisVector);
[47d041]304 // LOG(1, "SideH: " << SideH);
[3d919e]305
[357fba]306 // calculate each length
[ad37ab]307 const double a = SideA.Norm();
308 //const double b = SideB.Norm();
309 //const double c = SideC.Norm();
310 const double h = SideH.Norm();
[357fba]311 // calculate the angles
[273382]312 const double alpha = SideA.Angle(SideH);
313 const double beta = SideA.Angle(SideC);
314 const double gamma = SideB.Angle(SideH);
315 const double delta = SideC.Angle(SideH);
[ad37ab]316 const double MinDistance = a * sin(beta) / (sin(delta)) * (((alpha < M_PI / 2.) || (gamma < M_PI / 2.)) ? 1. : -1.);
[47d041]317 //LOG(1, " I calculated: a = " << a << ", h = " << h << ", beta(" << left->second.second->Name << "," << left->second.second->Name << "-" << right->second.second->Name << ") = " << beta << ", delta(" << left->second.second->Name << "," << runner->second.second->Name << ") = " << delta << ", Min = " << MinDistance << ".");
318 LOG(1, "Checking CoG distance of runner " << *runner->second.second << " " << h << " against triangle's side length spanned by (" << *left->second.second << "," << *right->second.second << ") of " << MinDistance << ".");
[357fba]319 if ((fabs(h / fabs(h) - MinDistance / fabs(MinDistance)) < MYEPSILON) && ((h - MinDistance)) < -MYEPSILON) {
320 // throw out point
[47d041]321 LOG(1, "Throwing out " << *runner->second.second << ".");
[357fba]322 BoundaryPoints[axis].erase(runner);
[accebe]323 runner = right;
[357fba]324 flag = true;
[3d919e]325 }
326 }
327 }
[357fba]328 } while (flag);
[3d919e]329 }
[357fba]330 delete(MolCenter);
331 return BoundaryPoints;
[6ac7ee]332};
333
[357fba]334/** Tesselates the convex boundary by finding all boundary points.
335 * \param *out output stream for debugging
[776b64]336 * \param *mol molecule structure with Atom's and Bond's.
[bdc91e]337 * \param *BoundaryPts set of boundary points to use or NULL
[357fba]338 * \param *TesselStruct Tesselation filled with points, lines and triangles on boundary on return
[6bd7e0]339 * \param *LCList atoms in LinkedCell_deprecated list
[357fba]340 * \param *filename filename prefix for output of vertex data
341 * \return *TesselStruct is filled with convex boundary and tesselation is stored under \a *filename.
[6ac7ee]342 */
[6bd7e0]343void FindConvexBorder(const molecule* mol, Boundaries *BoundaryPts, Tesselation *&TesselStruct, const LinkedCell_deprecated *LCList, const char *filename)
[6ac7ee]344{
[ce7bfd]345 //Info FunctionInfo(__func__);
[357fba]346 bool BoundaryFreeFlag = false;
347 Boundaries *BoundaryPoints = NULL;
[3d919e]348
[776b64]349 if (TesselStruct != NULL) // free if allocated
350 delete(TesselStruct);
351 TesselStruct = new class Tesselation;
[3d919e]352
[357fba]353 // 1. Find all points on the boundary
[bdc91e]354 if (BoundaryPts == NULL) {
355 BoundaryFreeFlag = true;
356 BoundaryPoints = GetBoundaryPoints(mol, TesselStruct);
[357fba]357 } else {
[bdc91e]358 BoundaryPoints = BoundaryPts;
[47d041]359 LOG(0, "Using given boundary points set.");
[3d919e]360 }
361
[357fba]362// printing all inserted for debugging
[47d041]363 if (DoLog(1)) {
364 for (int axis=0; axis < NDIM; axis++) {
365 std::stringstream output;
366 output << "Printing list of candidates for axis " << axis << " which we have inserted so far: ";
367 int i=0;
368 for(Boundaries::iterator runner = BoundaryPoints[axis].begin(); runner != BoundaryPoints[axis].end(); runner++) {
369 if (runner != BoundaryPoints[axis].begin())
370 output << ", " << i << ": " << *runner->second.second;
371 else
372 output << i << ": " << *runner->second.second;
373 i++;
374 }
375 LOG(1, output.str());
[a37350]376 }
[bdc91e]377 }
[3d919e]378
[357fba]379 // 2. fill the boundary point list
380 for (int axis = 0; axis < NDIM; axis++)
381 for (Boundaries::iterator runner = BoundaryPoints[axis].begin(); runner != BoundaryPoints[axis].end(); runner++)
[776b64]382 if (!TesselStruct->AddBoundaryPoint(runner->second.second, 0))
[47d041]383 LOG(2, "Point " << *(runner->second.second) << " is already present.");
[e4ea46]384
[47d041]385 LOG(0, "I found " << TesselStruct->PointsOnBoundaryCount << " points on the convex boundary.");
[357fba]386 // now we have the whole set of edge points in the BoundaryList
[018741]387
[357fba]388 // listing for debugging
[47d041]389 //if (DoLog(1)) {
390 // std::stringstream output;
391 // output << "Listing PointsOnBoundary:";
[357fba]392 // for(PointMap::iterator runner = PointsOnBoundary.begin(); runner != PointsOnBoundary.end(); runner++) {
[47d041]393 // output << " " << *runner->second;
[357fba]394 // }
[47d041]395 // LOG(1, output.str());
396 //}
[018741]397
[357fba]398 // 3a. guess starting triangle
[e138de]399 TesselStruct->GuessStartingTriangle();
[018741]400
[357fba]401 // 3b. go through all lines, that are not yet part of two triangles (only of one so far)
[caa06ef]402 PointCloudAdaptor< molecule > cloud(const_cast<molecule *>(mol), mol->name);
[34c43a]403 TesselStruct->TesselateOnBoundary(cloud);
[3d919e]404
[357fba]405 // 3c. check whether all atoms lay inside the boundary, if not, add to boundary points, segment triangle into three with the new point
[34c43a]406 if (!TesselStruct->InsertStraddlingPoints(cloud, LCList))
[47d041]407 ELOG(1, "Insertion of straddling points failed!");
[3d919e]408
[47d041]409 LOG(0, "I created " << TesselStruct->TrianglesOnBoundary.size() << " intermediate triangles with " << TesselStruct->LinesOnBoundary.size() << " lines and " << TesselStruct->PointsOnBoundary.size() << " points.");
[ef0e6d]410
411 // 4. Store triangles in tecplot file
[d51975]412 StoreTrianglesinFile(mol, TesselStruct, filename, "_intermed");
[ef0e6d]413
[357fba]414 // 3d. check all baselines whether the peaks of the two adjacent triangles with respect to center of baseline are convex, if not, make the baseline between the two peaks and baseline endpoints become the new peaks
[ad37ab]415 bool AllConvex = true;
[093645]416 class BoundaryLineSet *line = NULL;
417 do {
418 AllConvex = true;
[776b64]419 for (LineMap::iterator LineRunner = TesselStruct->LinesOnBoundary.begin(); LineRunner != TesselStruct->LinesOnBoundary.end(); LineRunner++) {
[093645]420 line = LineRunner->second;
[47d041]421 LOG(1, "INFO: Current line is " << *line << ".");
[e138de]422 if (!line->CheckConvexityCriterion()) {
[47d041]423 LOG(1, "... line " << *line << " is concave, flipping it.");
[093645]424
425 // flip the line
[e138de]426 if (TesselStruct->PickFarthestofTwoBaselines(line) == 0.)
[47d041]427 ELOG(1, "Correction of concave baselines failed!");
[57066a]428 else {
[e138de]429 TesselStruct->FlipBaseline(line);
[47d041]430 LOG(1, "INFO: Correction of concave baselines worked.");
[accebe]431 LineRunner = TesselStruct->LinesOnBoundary.begin(); // LineRunner may have been erase if line was deleted from LinesOnBoundary
[57066a]432 }
[093645]433 }
434 }
435 } while (!AllConvex);
[3d919e]436
[ef0e6d]437 // 3e. we need another correction here, for TesselPoints that are below the surface (i.e. have an odd number of concave triangles surrounding it)
[776b64]438// if (!TesselStruct->CorrectConcaveTesselPoints(out))
[47d041]439// ELOG(1, "Correction of concave tesselpoints failed!");
[ef0e6d]440
[47d041]441 LOG(0, "I created " << TesselStruct->TrianglesOnBoundary.size() << " triangles with " << TesselStruct->LinesOnBoundary.size() << " lines and " << TesselStruct->PointsOnBoundary.size() << " points.");
[3d919e]442
[357fba]443 // 4. Store triangles in tecplot file
[d51975]444 StoreTrianglesinFile(mol, TesselStruct, filename, "");
[ef0e6d]445
[357fba]446 // free reference lists
447 if (BoundaryFreeFlag)
448 delete[] (BoundaryPoints);
[3d919e]449};
[6ac7ee]450
[d4fa23]451/** For testing removes one boundary point after another to check for leaks.
452 * \param *out output stream for debugging
453 * \param *TesselStruct Tesselation containing envelope with boundary points
454 * \param *mol molecule
455 * \param *filename name of file
456 * \return true - all removed, false - something went wrong
457 */
[e138de]458bool RemoveAllBoundaryPoints(class Tesselation *&TesselStruct, const molecule * const mol, const char * const filename)
[d4fa23]459{
[ce7bfd]460 //Info FunctionInfo(__func__);
[d4fa23]461 int i=0;
462 char number[MAXSTRINGSIZE];
463
464 if ((TesselStruct == NULL) || (TesselStruct->PointsOnBoundary.empty())) {
[47d041]465 ELOG(1, "TesselStruct is empty.");
[d4fa23]466 return false;
467 }
468
469 PointMap::iterator PointRunner;
470 while (!TesselStruct->PointsOnBoundary.empty()) {
[47d041]471 if (DoLog(1)) {
472 std::stringstream output;
473 output << "Remaining points are: ";
474 for (PointMap::iterator PointSprinter = TesselStruct->PointsOnBoundary.begin(); PointSprinter != TesselStruct->PointsOnBoundary.end(); PointSprinter++)
475 output << *(PointSprinter->second) << "\t";
476 LOG(1, output.str());
477 }
[d4fa23]478
479 PointRunner = TesselStruct->PointsOnBoundary.begin();
480 // remove point
[e138de]481 TesselStruct->RemovePointFromTesselatedSurface(PointRunner->second);
[d4fa23]482
483 // store envelope
484 sprintf(number, "-%04d", i++);
[e138de]485 StoreTrianglesinFile(mol, (const Tesselation *&)TesselStruct, filename, number);
[d4fa23]486 }
487
488 return true;
489};
490
[08ef35]491/** Creates a convex envelope from a given non-convex one.
[093645]492 * -# First step, remove concave spots, i.e. singular "dents"
493 * -# We go through all PointsOnBoundary.
494 * -# We CheckConvexityCriterion() for all its lines.
495 * -# If all its lines are concave, it cannot be on the convex envelope.
496 * -# Hence, we remove it and re-create all its triangles from its getCircleOfConnectedPoints()
497 * -# We calculate the additional volume.
498 * -# We go over all lines until none yields a concavity anymore.
499 * -# Second step, remove concave lines, i.e. line-shape "dents"
500 * -# We go through all LinesOnBoundary
501 * -# We CheckConvexityCriterion()
502 * -# If it returns concave, we flip the line in this quadrupel of points (abusing the degeneracy of the tesselation)
503 * -# We CheckConvexityCriterion(),
504 * -# if it's concave, we continue
505 * -# if not, we mark an error and stop
[08ef35]506 * Note: This routine - for free - calculates the difference in volume between convex and
[ee0032]507 * non-convex envelope, as the former is easy to calculate - Tesselation::getVolumeOfConvexEnvelope() - it
[08ef35]508 * can be used to compute volumes of arbitrary shapes.
509 * \param *out output stream for debugging
510 * \param *TesselStruct non-convex envelope, is changed in return!
[093645]511 * \param *mol molecule
512 * \param *filename name of file
[08ef35]513 * \return volume difference between the non- and the created convex envelope
514 */
[e138de]515double ConvexizeNonconvexEnvelope(class Tesselation *&TesselStruct, const molecule * const mol, const char * const filename)
[08ef35]516{
[ce7bfd]517 //Info FunctionInfo(__func__);
[08ef35]518 double volume = 0;
519 class BoundaryPointSet *point = NULL;
520 class BoundaryLineSet *line = NULL;
[ad37ab]521 bool Concavity = false;
[57066a]522 char dummy[MAXSTRINGSIZE];
[ad37ab]523 PointMap::iterator PointRunner;
524 PointMap::iterator PointAdvance;
525 LineMap::iterator LineRunner;
526 LineMap::iterator LineAdvance;
527 TriangleMap::iterator TriangleRunner;
528 TriangleMap::iterator TriangleAdvance;
529 int run = 0;
[093645]530
531 // check whether there is something to work on
[08ef35]532 if (TesselStruct == NULL) {
[47d041]533 ELOG(1, "TesselStruct is empty!");
[08ef35]534 return volume;
535 }
536
[093645]537 // First step: RemovePointFromTesselatedSurface
[1d9b7aa]538 do {
539 Concavity = false;
[57066a]540 sprintf(dummy, "-first-%d", run);
[e138de]541 //CalculateConcavityPerBoundaryPoint(TesselStruct);
542 StoreTrianglesinFile(mol, (const Tesselation *&)TesselStruct, filename, dummy);
[57066a]543
[1d9b7aa]544 PointRunner = TesselStruct->PointsOnBoundary.begin();
545 PointAdvance = PointRunner; // we need an advanced point, as the PointRunner might get removed
546 while (PointRunner != TesselStruct->PointsOnBoundary.end()) {
547 PointAdvance++;
548 point = PointRunner->second;
[47d041]549 LOG(1, "INFO: Current point is " << *point << ".");
[1d9b7aa]550 for (LineMap::iterator LineRunner = point->lines.begin(); LineRunner != point->lines.end(); LineRunner++) {
551 line = LineRunner->second;
[47d041]552 LOG(1, "INFO: Current line of point " << *point << " is " << *line << ".");
[e138de]553 if (!line->CheckConvexityCriterion()) {
[57066a]554 // remove the point if needed
[47d041]555 LOG(1, "... point " << *point << " cannot be on convex envelope.");
[e138de]556 volume += TesselStruct->RemovePointFromTesselatedSurface(point);
[57066a]557 sprintf(dummy, "-first-%d", ++run);
[e138de]558 StoreTrianglesinFile(mol, (const Tesselation *&)TesselStruct, filename, dummy);
[57066a]559 Concavity = true;
560 break;
561 }
[1d9b7aa]562 }
563 PointRunner = PointAdvance;
[093645]564 }
565
[57066a]566 sprintf(dummy, "-second-%d", run);
[e138de]567 //CalculateConcavityPerBoundaryPoint(TesselStruct);
568 StoreTrianglesinFile(mol, (const Tesselation *&)TesselStruct, filename, dummy);
[093645]569
[1d9b7aa]570 // second step: PickFarthestofTwoBaselines
571 LineRunner = TesselStruct->LinesOnBoundary.begin();
572 LineAdvance = LineRunner; // we need an advanced line, as the LineRunner might get removed
573 while (LineRunner != TesselStruct->LinesOnBoundary.end()) {
574 LineAdvance++;
575 line = LineRunner->second;
[47d041]576 LOG(1, "INFO: Picking farthest baseline for line is " << *line << ".");
[1d9b7aa]577 // take highest of both lines
[e138de]578 if (TesselStruct->IsConvexRectangle(line) == NULL) {
579 const double tmp = TesselStruct->PickFarthestofTwoBaselines(line);
[57066a]580 volume += tmp;
[ad37ab]581 if (tmp != 0.) {
[e138de]582 TesselStruct->FlipBaseline(line);
[57066a]583 Concavity = true;
584 }
[1d9b7aa]585 }
586 LineRunner = LineAdvance;
587 }
[57066a]588 run++;
[1d9b7aa]589 } while (Concavity);
[e138de]590 //CalculateConcavityPerBoundaryPoint(TesselStruct);
591 //StoreTrianglesinFile(mol, filename, "-third");
[093645]592
593 // third step: IsConvexRectangle
[7dea7c]594// LineRunner = TesselStruct->LinesOnBoundary.begin();
595// LineAdvance = LineRunner; // we need an advanced line, as the LineRunner might get removed
596// while (LineRunner != TesselStruct->LinesOnBoundary.end()) {
597// LineAdvance++;
598// line = LineRunner->second;
[47d041]599// LOG(1, "INFO: Current line is " << *line << ".");
[7dea7c]600// //if (LineAdvance != TesselStruct->LinesOnBoundary.end())
[47d041]601// //LOG(1, "INFO: Next line will be " << *(LineAdvance->second) << ".");
[7dea7c]602// if (!line->CheckConvexityCriterion(out)) {
[47d041]603// LOG(1, "INFO: ... line " << *line << " is concave, flipping it.");
[7dea7c]604//
605// // take highest of both lines
[e138de]606// point = TesselStruct->IsConvexRectangle(line);
[7dea7c]607// if (point != NULL)
[e138de]608// volume += TesselStruct->RemovePointFromTesselatedSurface(point);
[7dea7c]609// }
610// LineRunner = LineAdvance;
611// }
[093645]612
[e138de]613 CalculateConcavityPerBoundaryPoint(TesselStruct);
614 StoreTrianglesinFile(mol, (const Tesselation *&)TesselStruct, filename, "");
[0077b5]615
616 // end
[47d041]617 LOG(0, "Volume is " << volume << ".");
[0077b5]618 return volume;
619};
620
[6ac7ee]621
[7dea7c]622/** Stores triangles to file.
623 * \param *out output stream for debugging
624 * \param *mol molecule with atoms and bonds
[71b20e]625 * \param *TesselStruct Tesselation with boundary triangles
[7dea7c]626 * \param *filename prefix of filename
627 * \param *extraSuffix intermediate suffix
628 */
[71b20e]629void StoreTrianglesinFile(const molecule * const mol, const Tesselation * const TesselStruct, const char *filename, const char *extraSuffix)
[7dea7c]630{
[ce7bfd]631 //Info FunctionInfo(__func__);
[caa06ef]632 PointCloudAdaptor< molecule > cloud(const_cast<molecule *>(mol), mol->name);
[7dea7c]633 // 4. Store triangles in tecplot file
634 if (filename != NULL) {
635 if (DoTecplotOutput) {
636 string OutputName(filename);
637 OutputName.append(extraSuffix);
638 OutputName.append(TecplotSuffix);
639 ofstream *tecplot = new ofstream(OutputName.c_str());
[34c43a]640 WriteTecplotFile(tecplot, TesselStruct, cloud, -1);
[7dea7c]641 tecplot->close();
642 delete(tecplot);
643 }
644 if (DoRaster3DOutput) {
645 string OutputName(filename);
646 OutputName.append(extraSuffix);
647 OutputName.append(Raster3DSuffix);
648 ofstream *rasterplot = new ofstream(OutputName.c_str());
[34c43a]649 WriteRaster3dFile(rasterplot, TesselStruct, cloud);
[7dea7c]650 rasterplot->close();
651 delete(rasterplot);
652 }
653 }
654};
[03648b]655
[357fba]656/** Creates multiples of the by \a *mol given cluster and suspends them in water with a given final density.
[ee0032]657 * We get cluster volume by Tesselation::getVolumeOfConvexEnvelope() and its diameters by GetDiametersOfCluster()
[accebe]658 * TODO: Here, we need a VolumeOfGeneralEnvelope (i.e. non-convex one)
[357fba]659 * \param *out output stream for debugging
660 * \param *configuration needed for path to store convex envelope file
661 * \param *mol molecule structure representing the cluster
[776b64]662 * \param *&TesselStruct Tesselation structure with triangles on return
[ee0032]663 * \param ClusterVolume guesstimated cluster volume, if equal 0 we used Tesselation::getVolumeOfConvexEnvelope() instead.
[357fba]664 * \param celldensity desired average density in final cell
[8c54a3]665 */
[e138de]666void PrepareClustersinWater(config *configuration, molecule *mol, double ClusterVolume, double celldensity)
[357fba]667{
[ce7bfd]668 //Info FunctionInfo(__func__);
[fa649a]669 bool IsAngstroem = true;
[ad37ab]670 double *GreatestDiameter = NULL;
671 Boundaries *BoundaryPoints = NULL;
672 class Tesselation *TesselStruct = NULL;
673 Vector BoxLengths;
674 int repetition[NDIM] = { 1, 1, 1 };
675 int TotalNoClusters = 1;
676 double totalmass = 0.;
677 double clustervolume = 0.;
678 double cellvolume = 0.;
679
[6e5084]680 // transform to PAS by Action
681 Vector MainAxis(0.,0.,1.);
[1f91f4]682 mol->RotateToPrincipalAxisSystem(MainAxis);
[3d919e]683
[ad37ab]684 IsAngstroem = configuration->GetIsAngstroem();
[e138de]685 BoundaryPoints = GetBoundaryPoints(mol, TesselStruct);
[bdc91e]686 GreatestDiameter = GetDiametersOfCluster(BoundaryPoints, mol, TesselStruct, IsAngstroem);
[caa06ef]687 PointCloudAdaptor< molecule > cloud(mol, mol->name);
[6bd7e0]688 LinkedCell_deprecated *LCList = new LinkedCell_deprecated(cloud, 10.);
689 FindConvexBorder(mol, BoundaryPoints, TesselStruct, (const LinkedCell_deprecated *&)LCList, NULL);
[accebe]690 delete (LCList);
[bdc91e]691 delete[] BoundaryPoints;
[accebe]692
[ad37ab]693
694 // some preparations beforehand
[357fba]695 if (ClusterVolume == 0)
[ee0032]696 clustervolume = TesselStruct->getVolumeOfConvexEnvelope(configuration->GetIsAngstroem());
[357fba]697 else
698 clustervolume = ClusterVolume;
[ad37ab]699
[bdc91e]700 delete TesselStruct;
701
[357fba]702 for (int i = 0; i < NDIM; i++)
703 TotalNoClusters *= repetition[i];
[8c54a3]704
[357fba]705 // sum up the atomic masses
[9879f6]706 for (molecule::const_iterator iter = mol->begin(); iter != mol->end(); ++iter) {
[83f176]707 totalmass += (*iter)->getType()->getMass();
[ad37ab]708 }
[47d041]709 LOG(0, "RESULT: The summed mass is " << setprecision(10) << totalmass << " atomicmassunit.");
710 LOG(0, "RESULT: The average density is " << setprecision(10) << totalmass / clustervolume << " atomicmassunit/" << (IsAngstroem ? "angstrom" : "atomiclength") << "^3.");
[8c54a3]711
[357fba]712 // solve cubic polynomial
[47d041]713 LOG(1, "Solving equidistant suspension in water problem ...");
[357fba]714 if (IsAngstroem)
[ad37ab]715 cellvolume = (TotalNoClusters * totalmass / SOLVENTDENSITY_A - (totalmass / clustervolume)) / (celldensity - 1);
[357fba]716 else
[ad37ab]717 cellvolume = (TotalNoClusters * totalmass / SOLVENTDENSITY_a0 - (totalmass / clustervolume)) / (celldensity - 1);
[47d041]718 LOG(1, "Cellvolume needed for a density of " << celldensity << " g/cm^3 is " << cellvolume << " " << (IsAngstroem ? "angstrom" : "atomiclength") << "^3.");
[ad37ab]719
720 double minimumvolume = TotalNoClusters * (GreatestDiameter[0] * GreatestDiameter[1] * GreatestDiameter[2]);
[47d041]721 LOG(1, "Minimum volume of the convex envelope contained in a rectangular box is " << minimumvolume << " atomicmassunit/" << (IsAngstroem ? "angstrom" : "atomiclength") << "^3.");
[ad37ab]722 if (minimumvolume > cellvolume) {
[47d041]723 ELOG(1, "the containing box already has a greater volume than the envisaged cell volume!");
724 LOG(0, "Setting Box dimensions to minimum possible, the greatest diameters.");
[ad37ab]725 for (int i = 0; i < NDIM; i++)
[0a4f7f]726 BoxLengths[i] = GreatestDiameter[i];
[e138de]727 mol->CenterEdge(&BoxLengths);
[ad37ab]728 } else {
[0a4f7f]729 BoxLengths[0] = (repetition[0] * GreatestDiameter[0] + repetition[1] * GreatestDiameter[1] + repetition[2] * GreatestDiameter[2]);
730 BoxLengths[1] = (repetition[0] * repetition[1] * GreatestDiameter[0] * GreatestDiameter[1] + repetition[0] * repetition[2] * GreatestDiameter[0] * GreatestDiameter[2] + repetition[1] * repetition[2] * GreatestDiameter[1] * GreatestDiameter[2]);
731 BoxLengths[2] = minimumvolume - cellvolume;
[ad37ab]732 double x0 = 0.;
733 double x1 = 0.;
734 double x2 = 0.;
[0a4f7f]735 if (gsl_poly_solve_cubic(BoxLengths[0], BoxLengths[1], BoxLengths[2], &x0, &x1, &x2) == 1) // either 1 or 3 on return
[47d041]736 LOG(0, "RESULT: The resulting spacing is: " << x0 << " .");
[ad37ab]737 else {
[47d041]738 LOG(0, "RESULT: The resulting spacings are: " << x0 << " and " << x1 << " and " << x2 << " .");
[ad37ab]739 x0 = x2; // sorted in ascending order
[357fba]740 }
[8c54a3]741
[ad37ab]742 cellvolume = 1.;
743 for (int i = 0; i < NDIM; i++) {
[0a4f7f]744 BoxLengths[i] = repetition[i] * (x0 + GreatestDiameter[i]);
745 cellvolume *= BoxLengths[i];
[8c54a3]746 }
[ad37ab]747
748 // set new box dimensions
[47d041]749 LOG(0, "Translating to box with these boundaries.");
[ad37ab]750 mol->SetBoxDimension(&BoxLengths);
[e138de]751 mol->CenterInBox();
[ad37ab]752 }
[bdc91e]753 delete GreatestDiameter;
[357fba]754 // update Box of atoms by boundary
755 mol->SetBoxDimension(&BoxLengths);
[47d041]756 LOG(0, "RESULT: The resulting cell dimensions are: " << BoxLengths[0] << " and " << BoxLengths[1] << " and " << BoxLengths[2] << " with total volume of " << cellvolume << " " << (IsAngstroem ? "angstrom" : "atomiclength") << "^3.");
[ad37ab]757};
[8c54a3]758
759
[eee966]760/** Fills the empty space around other molecules' surface of the simulation box with a filler.
[357fba]761 * \param *out output stream for debugging
762 * \param *List list of molecules already present in box
763 * \param *TesselStruct contains tesselated surface
764 * \param *filler molecule which the box is to be filled with
765 * \param configuration contains box dimensions
[775d133]766 * \param MaxDistance fills in molecules only up to this distance (set to -1 if whole of the domain)
[357fba]767 * \param distance[NDIM] distance between filling molecules in each direction
[9473f6]768 * \param boundary length of boundary zone between molecule and filling mollecules
[71b20e]769 * \param epsilon distance to surface which is not filled
[357fba]770 * \param RandAtomDisplacement maximum distance for random displacement per atom
771 * \param RandMolDisplacement maximum distance for random displacement per filler molecule
772 * \param DoRandomRotation true - do random rotiations, false - don't
[6ac7ee]773 */
[7a51be]774void FillBoxWithMolecule(MoleculeListClass *List, molecule *filler, config &configuration, const double MaxDistance, const double distance[NDIM], const double boundary, const double RandomAtomDisplacement, const double RandomMolDisplacement, const bool DoRandomRotation)
[6ac7ee]775{
[ce7bfd]776 //Info FunctionInfo(__func__);
[23b547]777 molecule *Filling = World::getInstance().createMolecule();
[357fba]778 Vector CurrentPosition;
779 int N[NDIM];
780 int n[NDIM];
[cca9ef]781 const RealSpaceMatrix &M = World::getInstance().getDomain().getM();
782 RealSpaceMatrix Rotations;
783 const RealSpaceMatrix &MInverse = World::getInstance().getDomain().getMinv();
[357fba]784 Vector AtomTranslations;
785 Vector FillerTranslations;
786 Vector FillerDistance;
[30d9e7]787 Vector Inserter;
[357fba]788 double FillIt = false;
[7d82a5]789 bond::ptr Binder;
[ad37ab]790 double phi[NDIM];
[30d9e7]791 map<molecule *, Tesselation *> TesselStruct;
[6bd7e0]792 map<molecule *, LinkedCell_deprecated *> LCList;
[ef0e6d]793
[c5805a]794 for (MoleculeList::iterator ListRunner = List->ListOfMolecules.begin(); ListRunner != List->ListOfMolecules.end(); ListRunner++)
[a7b761b]795 if ((*ListRunner)->getAtomCount() > 0) {
[47d041]796 LOG(1, "Pre-creating linked cell lists for molecule " << *ListRunner << ".");
[caa06ef]797 PointCloudAdaptor< molecule > cloud(*ListRunner, (*ListRunner)->name);
[6bd7e0]798 LCList[(*ListRunner)] = new LinkedCell_deprecated(cloud, 10.); // get linked cell list
[47d041]799 LOG(1, "Pre-creating tesselation for molecule " << *ListRunner << ".");
[c5805a]800 TesselStruct[(*ListRunner)] = NULL;
[6bd7e0]801 FindNonConvexBorder((*ListRunner), TesselStruct[(*ListRunner)], (const LinkedCell_deprecated *&)LCList[(*ListRunner)], 5., NULL);
[c5805a]802 }
[8c54a3]803
[357fba]804 // Center filler at origin
[c5805a]805 filler->CenterEdge(&Inserter);
[e0aee2b]806 const int FillerCount = filler->getAtomCount();
[47d041]807 LOG(2, "INFO: Filler molecule has the following bonds:");
[9d83b6]808 for(molecule::iterator AtomRunner = filler->begin(); AtomRunner != filler->end(); ++AtomRunner) {
809 const BondList& ListOfBonds = (*AtomRunner)->getListOfBonds();
810 for(BondList::const_iterator BondRunner = ListOfBonds.begin();
811 BondRunner != ListOfBonds.end();
812 ++BondRunner) {
[e08c46]813 if ((*BondRunner)->leftatom == *AtomRunner)
[47d041]814 LOG(2, " " << *(*BondRunner));
[9d83b6]815 }
816 }
[8c54a3]817
[e0aee2b]818 atom * CopyAtoms[FillerCount];
[ef0e6d]819
[357fba]820 // calculate filler grid in [0,1]^3
[5108e1]821 FillerDistance = MInverse * Vector(distance[0], distance[1], distance[2]);
[71b20e]822 for(int i=0;i<NDIM;i++)
[8cbb97]823 N[i] = (int) ceil(1./FillerDistance[i]);
[47d041]824 LOG(1, "INFO: Grid steps are " << N[0] << ", " << N[1] << ", " << N[2] << ".");
[8c54a3]825
[d6eb80]826 // initialize seed of random number generator to current time
[a5028f]827 RandomNumberGenerator &random = RandomNumberGeneratorFactory::getInstance().makeRandomNumberGenerator();
828 const double rng_min = random.min();
829 const double rng_max = random.max();
830 //srand ( time(NULL) );
[d6eb80]831
[357fba]832 // go over [0,1]^3 filler grid
833 for (n[0] = 0; n[0] < N[0]; n[0]++)
834 for (n[1] = 0; n[1] < N[1]; n[1]++)
835 for (n[2] = 0; n[2] < N[2]; n[2]++) {
836 // calculate position of current grid vector in untransformed box
[5108e1]837 CurrentPosition = M * Vector((double)n[0]/(double)N[0], (double)n[1]/(double)N[1], (double)n[2]/(double)N[2]);
[30d9e7]838 // create molecule random translation vector ...
839 for (int i=0;i<NDIM;i++)
[a5028f]840 FillerTranslations[i] = RandomMolDisplacement*(random()/((rng_max-rng_min)/2.) - 1.);
[47d041]841 LOG(2, "INFO: Current Position is " << CurrentPosition << "+" << FillerTranslations << ".");
[8c54a3]842
[30d9e7]843 // go through all atoms
[e0aee2b]844 for (int i=0;i<FillerCount;i++)
[c5805a]845 CopyAtoms[i] = NULL;
[0b15bb]846
847 // have same rotation angles for all molecule's atoms
848 if (DoRandomRotation)
849 for (int i=0;i<NDIM;i++)
[a5028f]850 phi[i] = (random()/(rng_max-rng_min))*(2.*M_PI);
[0b15bb]851
[59fff1]852 // atom::clone is not const member function, hence we need iterator here
853 for(molecule::iterator iter = filler->begin(); iter !=filler->end();++iter){
[8c54a3]854
[30d9e7]855 // create atomic random translation vector ...
[357fba]856 for (int i=0;i<NDIM;i++)
[a5028f]857 AtomTranslations[i] = RandomAtomDisplacement*(random()/((rng_max-rng_min)/2.) - 1.);
[8c54a3]858
[30d9e7]859 // ... and rotation matrix
860 if (DoRandomRotation) {
[a679d1]861 Rotations.set(0,0, cos(phi[0]) *cos(phi[2]) + (sin(phi[0])*sin(phi[1])*sin(phi[2])));
862 Rotations.set(0,1, sin(phi[0]) *cos(phi[2]) - (cos(phi[0])*sin(phi[1])*sin(phi[2])));
863 Rotations.set(0,2, cos(phi[1])*sin(phi[2]) );
864 Rotations.set(1,0, -sin(phi[0])*cos(phi[1]) );
865 Rotations.set(1,1, cos(phi[0])*cos(phi[1]) );
866 Rotations.set(1,2, sin(phi[1]) );
867 Rotations.set(2,0, -cos(phi[0]) *sin(phi[2]) + (sin(phi[0])*sin(phi[1])*cos(phi[2])));
868 Rotations.set(2,1, -sin(phi[0]) *sin(phi[2]) - (cos(phi[0])*sin(phi[1])*cos(phi[2])));
869 Rotations.set(2,2, cos(phi[1])*cos(phi[2]) );
[30d9e7]870 }
[8c54a3]871
[30d9e7]872 // ... and put at new position
[d74077]873 Inserter = (*iter)->getPosition();
[30d9e7]874 if (DoRandomRotation)
[5108e1]875 Inserter *= Rotations;
[8cbb97]876 Inserter += AtomTranslations + FillerTranslations + CurrentPosition;
[30d9e7]877
878 // check whether inserter is inside box
[5108e1]879 Inserter *= MInverse;
[30d9e7]880 FillIt = true;
[357fba]881 for (int i=0;i<NDIM;i++)
[8cbb97]882 FillIt = FillIt && (Inserter[i] >= -MYEPSILON) && ((Inserter[i]-1.) <= MYEPSILON);
[5108e1]883 Inserter *= M;
[30d9e7]884
885 // Check whether point is in- or outside
886 for (MoleculeList::iterator ListRunner = List->ListOfMolecules.begin(); ListRunner != List->ListOfMolecules.end(); ListRunner++) {
887 // get linked cell list
[c5805a]888 if (TesselStruct[(*ListRunner)] != NULL) {
[8db598]889 const double distance = (TesselStruct[(*ListRunner)]->GetDistanceToSurface(Inserter, LCList[(*ListRunner)]));
890 FillIt = FillIt && (distance > boundary) && ((MaxDistance < 0) || (MaxDistance > distance));
[30d9e7]891 }
892 }
893 // insert into Filling
894 if (FillIt) {
[47d041]895 LOG(1, "INFO: Position at " << Inserter << " is outer point.");
[357fba]896 // copy atom ...
[735b1c]897 CopyAtoms[(*iter)->getNr()] = (*iter)->clone();
898 (*CopyAtoms[(*iter)->getNr()]).setPosition(Inserter);
899 Filling->AddAtom(CopyAtoms[(*iter)->getNr()]);
[47d041]900 LOG(1, "Filling atom " << **iter << ", translated to " << AtomTranslations << ", at final position is " << (CopyAtoms[(*iter)->getNr()]->getPosition()) << ".");
[30d9e7]901 } else {
[47d041]902 LOG(1, "INFO: Position at " << Inserter << " is inner point, within boundary or outside of MaxDistance.");
[735b1c]903 CopyAtoms[(*iter)->getNr()] = NULL;
[c5805a]904 continue;
[357fba]905 }
[a837d0]906 }
907 // go through all bonds and add as well
[9d83b6]908 for(molecule::iterator AtomRunner = filler->begin(); AtomRunner != filler->end(); ++AtomRunner) {
909 const BondList& ListOfBonds = (*AtomRunner)->getListOfBonds();
910 for(BondList::const_iterator BondRunner = ListOfBonds.begin();
911 BondRunner != ListOfBonds.end();
912 ++BondRunner)
[e08c46]913 if ((*BondRunner)->leftatom == *AtomRunner) {
914 Binder = (*BondRunner);
[735b1c]915 if ((CopyAtoms[Binder->leftatom->getNr()] != NULL) && (CopyAtoms[Binder->rightatom->getNr()] != NULL)) {
[47d041]916 LOG(3, "Adding Bond between " << *CopyAtoms[Binder->leftatom->getNr()] << " and " << *CopyAtoms[Binder->rightatom->getNr()]<< ".");
[735b1c]917 Filling->AddBond(CopyAtoms[Binder->leftatom->getNr()], CopyAtoms[Binder->rightatom->getNr()], Binder->BondDegree);
[e08c46]918 }
919 }
[9d83b6]920 }
[8c54a3]921 }
[bdc91e]922 for (MoleculeList::iterator ListRunner = List->ListOfMolecules.begin(); ListRunner != List->ListOfMolecules.end(); ListRunner++) {
923 delete LCList[*ListRunner];
924 delete TesselStruct[(*ListRunner)];
925 }
[3d919e]926};
[8c54a3]927
[66fd49]928/** Rotates given molecule \a Filling and moves its atoms according to given
929 * \a RandomAtomDisplacement.
930 *
931 * Note that for rotation to be sensible, the molecule should be centered at
932 * the origin. This is not done here!
933 *
934 * \param &Filling molecule whose atoms to displace
935 * \param RandomAtomDisplacement magnitude of random displacement
936 * \param &Rotations 3D rotation matrix (or unity if no rotation desired)
937 */
938void RandomizeMoleculePositions(
939 molecule *&Filling,
940 double RandomAtomDisplacement,
[a5028f]941 RealSpaceMatrix &Rotations,
942 RandomNumberGenerator &random
[66fd49]943 )
944{
[a5028f]945 const double rng_min = random.min();
946 const double rng_max = random.max();
947
[66fd49]948 Vector AtomTranslations;
949 for(molecule::iterator miter = Filling->begin(); miter != Filling->end(); ++miter) {
950 Vector temp = (*miter)->getPosition();
951 temp *= Rotations;
952 (*miter)->setPosition(temp);
953 // create atomic random translation vector ...
954 for (int i=0;i<NDIM;i++)
[a5028f]955 AtomTranslations[i] = RandomAtomDisplacement*(random()/((rng_max-rng_min)/2.) - 1.);
[66fd49]956 (*miter)->setPosition((*miter)->getPosition() + AtomTranslations);
957 }
958}
959
960/** Removes all atoms of a molecule outside.
961 *
962 * If the molecule is empty, it is removed as well.
963 *
964 * @param Filling molecule whose atoms to check, removed if eventually left
965 * empty.
[9df680]966 * @return true - atoms had to be removed, false - no atoms have been removed
[66fd49]967 */
[9df680]968bool RemoveAtomsOutsideDomain(molecule *&Filling)
[66fd49]969{
[9df680]970 bool status = false;
[66fd49]971 Box &Domain = World::getInstance().getDomain();
972 // check if all is still inside domain
973 for(molecule::iterator miter = Filling->begin(); miter != Filling->end(); ) {
974 // check whether each atom is inside box
975 if (!Domain.isInside((*miter)->getPosition())) {
[9df680]976 status = true;
[66fd49]977 atom *Walker = *miter;
978 ++miter;
979 World::getInstance().destroyAtom(Walker);
980 } else {
981 ++miter;
982 }
983 }
984 if (Filling->empty()) {
[47d041]985 LOG(0, "Removing molecule " << Filling->getName() << ", all atoms have been removed.");
[66fd49]986 World::getInstance().destroyMolecule(Filling);
[2e352f]987 Filling = NULL;
[66fd49]988 }
[9df680]989 return status;
[66fd49]990}
991
992/** Checks whether there are no atoms inside a sphere around \a CurrentPosition
993 * except those atoms present in \a *filler.
[6bd7e0]994 * If filler is NULL, then we just call LinkedCell_deprecated::GetPointsInsideSphere() and
[66fd49]995 * check whether the return list is empty.
996 * @param *filler
997 * @param boundary
998 * @param CurrentPosition
999 */
1000bool isSpaceAroundPointVoid(
[6bd7e0]1001 LinkedCell_deprecated *LC,
[66fd49]1002 molecule *filler,
1003 const double boundary,
1004 Vector &CurrentPosition)
1005{
1006 size_t compareTo = 0;
[34c43a]1007 TesselPointSTLList* liste = LC->GetPointsInsideSphere(boundary == 0. ? MYEPSILON : boundary, &CurrentPosition);
[66fd49]1008 if (filler != NULL) {
[34c43a]1009 for (TesselPointSTLList::const_iterator iter = liste->begin();
[66fd49]1010 iter != liste->end();
1011 ++iter) {
1012 for (molecule::iterator miter = filler->begin();
1013 miter != filler->end();
1014 ++miter) {
1015 if (*iter == *miter)
1016 ++compareTo;
1017 }
1018 }
1019 }
1020 const bool result = (liste->size() == compareTo);
1021 if (!result) {
[47d041]1022 LOG(0, "Skipping because of the following atoms:");
[34c43a]1023 for (TesselPointSTLList::const_iterator iter = liste->begin();
[66fd49]1024 iter != liste->end();
1025 ++iter) {
[47d041]1026 LOG(0, **iter);
[66fd49]1027 }
1028 }
1029 delete(liste);
1030 return result;
1031}
1032
[b81f1c]1033/** Sets given 3x3 matrix to a random rotation matrix.
1034 *
1035 * @param a matrix to set
1036 */
1037inline void setRandomRotation(RealSpaceMatrix &a)
1038{
1039 double phi[NDIM];
1040 RandomNumberGenerator &random = RandomNumberGeneratorFactory::getInstance().makeRandomNumberGenerator();
1041 const double rng_min = random.min();
1042 const double rng_max = random.max();
1043
1044 for (int i=0;i<NDIM;i++) {
1045 phi[i] = (random()/(rng_max-rng_min))*(2.*M_PI);
[5a4cbc]1046 LOG(4, "DEBUG: Random angle is " << phi[i] << ".");
[b81f1c]1047 }
1048
[8766e72]1049 a.setRotation(phi);
[b81f1c]1050}
1051
[66fd49]1052/** Fills the empty space of the simulation box with water.
[eee966]1053 * \param *filler molecule which the box is to be filled with
1054 * \param configuration contains box dimensions
1055 * \param distance[NDIM] distance between filling molecules in each direction
[66fd49]1056 * \param boundary length of boundary zone between molecule and filling molecules
[eee966]1057 * \param RandAtomDisplacement maximum distance for random displacement per atom
1058 * \param RandMolDisplacement maximum distance for random displacement per filler molecule
[66fd49]1059 * \param MinDistance minimum distance to boundary of domain and present molecules
1060 * \param DoRandomRotation true - do random rotations, false - don't
[eee966]1061 */
[66fd49]1062void FillVoidWithMolecule(
1063 molecule *&filler,
1064 config &configuration,
1065 const double distance[NDIM],
1066 const double boundary,
1067 const double RandomAtomDisplacement,
1068 const double RandomMolDisplacement,
1069 const double MinDistance,
1070 const bool DoRandomRotation
1071 )
[eee966]1072{
[ce7bfd]1073 //Info FunctionInfo(__func__);
[eee966]1074 molecule *Filling = NULL;
1075 Vector CurrentPosition;
1076 int N[NDIM];
1077 int n[NDIM];
[cca9ef]1078 const RealSpaceMatrix &M = World::getInstance().getDomain().getM();
1079 RealSpaceMatrix Rotations;
1080 const RealSpaceMatrix &MInverse = World::getInstance().getDomain().getMinv();
[eee966]1081 Vector FillerTranslations;
1082 Vector FillerDistance;
1083 Vector Inserter;
1084 double FillIt = false;
[66fd49]1085 Vector firstInserter;
1086 bool firstInsertion = true;
1087 const Box &Domain = World::getInstance().getDomain();
[6bd7e0]1088 map<molecule *, LinkedCell_deprecated *> LCList;
[eee966]1089 std::vector<molecule *> List = World::getInstance().getAllMolecules();
1090 MoleculeListClass *MolList = World::getInstance().getMolecules();
1091
1092 for (std::vector<molecule *>::iterator ListRunner = List.begin(); ListRunner != List.end(); ListRunner++)
1093 if ((*ListRunner)->getAtomCount() > 0) {
[47d041]1094 LOG(1, "Pre-creating linked cell lists for molecule " << *ListRunner << ".");
[caa06ef]1095 PointCloudAdaptor< molecule > cloud(*ListRunner, (*ListRunner)->name);
[6bd7e0]1096 LCList[(*ListRunner)] = new LinkedCell_deprecated(cloud, 10.); // get linked cell list
[eee966]1097 }
1098
[9df680]1099 // Center filler at its center of gravity
1100 Vector *gravity = filler->DetermineCenterOfGravity();
1101 filler->CenterAtVector(gravity);
1102 delete gravity;
[66fd49]1103 //const int FillerCount = filler->getAtomCount();
[47d041]1104 LOG(2, "INFO: Filler molecule has the following bonds:");
[9d83b6]1105 for(molecule::iterator AtomRunner = filler->begin(); AtomRunner != filler->end(); ++AtomRunner) {
1106 const BondList& ListOfBonds = (*AtomRunner)->getListOfBonds();
1107 for(BondList::const_iterator BondRunner = ListOfBonds.begin();
1108 BondRunner != ListOfBonds.end();
1109 ++BondRunner)
[eee966]1110 if ((*BondRunner)->leftatom == *AtomRunner)
[47d041]1111 LOG(2, " " << *(*BondRunner));
[9d83b6]1112 }
[eee966]1113
1114 // calculate filler grid in [0,1]^3
1115 FillerDistance = MInverse * Vector(distance[0], distance[1], distance[2]);
1116 for(int i=0;i<NDIM;i++)
1117 N[i] = (int) ceil(1./FillerDistance[i]);
[47d041]1118 LOG(1, "INFO: Grid steps are " << N[0] << ", " << N[1] << ", " << N[2] << ".");
[eee966]1119
1120 // initialize seed of random number generator to current time
[a5028f]1121 RandomNumberGenerator &random = RandomNumberGeneratorFactory::getInstance().makeRandomNumberGenerator();
1122 const double rng_min = random.min();
1123 const double rng_max = random.max();
1124 //srand ( time(NULL) );
[eee966]1125
1126 // go over [0,1]^3 filler grid
1127 for (n[0] = 0; n[0] < N[0]; n[0]++)
1128 for (n[1] = 0; n[1] < N[1]; n[1]++)
1129 for (n[2] = 0; n[2] < N[2]; n[2]++) {
1130 // calculate position of current grid vector in untransformed box
1131 CurrentPosition = M * Vector((double)n[0]/(double)N[0], (double)n[1]/(double)N[1], (double)n[2]/(double)N[2]);
1132 // create molecule random translation vector ...
[a5028f]1133 for (int i=0;i<NDIM;i++) // have the random values [-1,1]*RandomMolDisplacement
1134 FillerTranslations[i] = RandomMolDisplacement*(random()/((rng_max-rng_min)/2.) - 1.);
[47d041]1135 LOG(2, "INFO: Current Position is " << CurrentPosition << "+" << FillerTranslations << ".");
[eee966]1136
1137 // ... and rotation matrix
[66fd49]1138 if (DoRandomRotation)
[b81f1c]1139 setRandomRotation(Rotations);
[66fd49]1140 else
1141 Rotations.setIdentity();
[eee966]1142
1143
[66fd49]1144 // Check whether there is anything too close by and whether atom is outside of domain
[eee966]1145 FillIt = true;
[6bd7e0]1146 for (std::map<molecule *, LinkedCell_deprecated *>::iterator ListRunner = LCList.begin(); ListRunner != LCList.end(); ++ListRunner) {
[66fd49]1147 FillIt = FillIt && isSpaceAroundPointVoid(
1148 ListRunner->second,
1149 (firstInsertion ? filler : NULL),
1150 boundary,
1151 CurrentPosition);
[2a0271]1152 FillIt = FillIt && (Domain.isValid(CurrentPosition))
[66fd49]1153 && ((Domain.DistanceToBoundary(CurrentPosition) - MinDistance) > -MYEPSILON);
1154 if (!FillIt)
1155 break;
[eee966]1156 }
[66fd49]1157
[eee966]1158 // insert into Filling
1159 if (FillIt) {
1160 Inserter = CurrentPosition + FillerTranslations;
[47d041]1161 LOG(1, "INFO: Position at " << Inserter << " is void point.");
[66fd49]1162 // fill!
[9df680]1163 Filling = filler->CopyMolecule();
[a5028f]1164 RandomizeMoleculePositions(Filling, RandomAtomDisplacement, Rotations, random);
[9df680]1165 // translation
1166 Filling->Translate(&Inserter);
1167 // remove out-of-bounds atoms
1168 const bool status = RemoveAtomsOutsideDomain(Filling);
1169 if ((firstInsertion) && (!status)) { // no atom has been removed
1170 // remove copied atoms and molecule again
1171 Filling->removeAtomsinMolecule();
1172 World::getInstance().destroyMolecule(Filling);
1173 // and mark is final filler position
[66fd49]1174 Filling = filler;
1175 firstInsertion = false;
1176 firstInserter = Inserter;
[9df680]1177 } else {
[66fd49]1178 // TODO: Remove when World has no MoleculeListClass anymore
[69948e]1179 if (Filling)
1180 MolList->insert(Filling);
[eee966]1181 }
1182 } else {
[47d041]1183 LOG(1, "INFO: Position at " << Inserter << " is non-void point, within boundary or outside of MaxDistance.");
[2a0271]1184 continue;
1185 }
1186 }
1187
1188 // have we inserted any molecules?
1189 if (firstInsertion) {
1190 // If not remove filler
1191 for(molecule::iterator miter = filler->begin(); !filler->empty(); miter = filler->begin()) {
1192 atom *Walker = *miter;
1193 World::getInstance().destroyAtom(Walker);
1194 }
1195 World::getInstance().destroyMolecule(filler);
1196 } else {
1197 // otherwise translate and randomize to final position
1198 if (DoRandomRotation)
1199 setRandomRotation(Rotations);
1200 else
1201 Rotations.setIdentity();
1202 RandomizeMoleculePositions(filler, RandomAtomDisplacement, Rotations, random);
1203 // translation
1204 filler->Translate(&firstInserter);
1205 // remove out-of-bounds atoms
1206 RemoveAtomsOutsideDomain(filler);
1207 }
1208
1209 LOG(0, MolList->ListOfMolecules.size() << " molecules have been inserted.");
1210
1211 for (std::map<molecule *, LinkedCell_deprecated *>::iterator ListRunner = LCList.begin(); !LCList.empty(); ListRunner = LCList.begin()) {
1212 delete ListRunner->second;
1213 LCList.erase(ListRunner);
1214 }
1215};
1216
1217
1218/** Fills the empty space around other molecules' surface of the simulation box with a filler.
1219 *
1220 * Note that we use \a FindNonConvexBorder to determine the surface of the found molecules.
1221 * There, we use a radius of twice the given \a boundary.
1222 *
1223 * \param *out output stream for debugging
1224 * \param *List list of molecules already present in box
1225 * \param *TesselStruct contains tesselated surface
1226 * \param *filler molecule which the box is to be filled with
1227 * \param configuration contains box dimensions
1228 * \param MaxSurfaceDistance fills in molecules only up to this distance (set to -1 if whole of the domain)
1229 * \param distance[NDIM] distance between filling molecules in each direction
1230 * \param boundary length of boundary zone between molecule and filling molecules
1231 * \param MinDistance distance to boundary of domain which is not filled
1232 * \param RandAtomDisplacement maximum distance for random displacement per atom
1233 * \param RandMolDisplacement maximum distance for random displacement per filler molecule
1234 * \param DoRandomRotation true - do random rotations, false - don't
1235 */
1236void FillBoxWithMolecule(
1237 MoleculeListClass *MolList,
1238 molecule *filler,
1239 config &configuration,
1240 const double MaxSurfaceDistance,
1241 const double distance[NDIM],
1242 const double boundary,
1243 const double MinDistance,
1244 const double RandomAtomDisplacement,
1245 const double RandomMolDisplacement,
1246 const bool DoRandomRotation)
1247{
[ce7bfd]1248 //Info FunctionInfo(__func__);
[2a0271]1249 molecule *Filling = NULL;
1250 Vector CurrentPosition;
1251 int N[NDIM];
1252 int n[NDIM];
1253 const RealSpaceMatrix &M = World::getInstance().getDomain().getM();
1254 RealSpaceMatrix Rotations;
1255 const RealSpaceMatrix &MInverse = World::getInstance().getDomain().getMinv();
1256 Vector FillerTranslations;
1257 Vector FillerDistance;
1258 Vector Inserter;
1259 double FillIt = false;
1260 Vector firstInserter;
1261 bool firstInsertion = true;
1262 const Box &Domain = World::getInstance().getDomain();
1263 map<molecule *, LinkedCell_deprecated *> LCList;
1264 std::vector<molecule *> List = World::getInstance().getAllMolecules();
1265 map<molecule *, Tesselation *> TesselStruct;
1266
1267 for (MoleculeList::iterator ListRunner = MolList->ListOfMolecules.begin(); ListRunner != MolList->ListOfMolecules.end(); ListRunner++)
1268 if ((*ListRunner)->getAtomCount() > 0) {
1269 LOG(1, "Pre-creating linked cell lists for molecule " << *ListRunner << ".");
1270 PointCloudAdaptor< molecule > cloud(*ListRunner, (*ListRunner)->name);
1271 LCList[(*ListRunner)] = new LinkedCell_deprecated(cloud, 4.*boundary); // get linked cell list
1272 LOG(1, "Pre-creating tesselation for molecule " << *ListRunner << ".");
1273 TesselStruct[(*ListRunner)] = NULL;
1274 FindNonConvexBorder((*ListRunner), TesselStruct[(*ListRunner)], (const LinkedCell_deprecated *&)LCList[(*ListRunner)], 2.*boundary, NULL);
1275 }
1276
1277 // Center filler at origin
1278 filler->CenterEdge(&Inserter);
1279 const int FillerCount = filler->getAtomCount();
1280 LOG(2, "INFO: Filler molecule has the following bonds:");
1281 for(molecule::iterator AtomRunner = filler->begin(); AtomRunner != filler->end(); ++AtomRunner) {
1282 const BondList& ListOfBonds = (*AtomRunner)->getListOfBonds();
1283 for(BondList::const_iterator BondRunner = ListOfBonds.begin();
1284 BondRunner != ListOfBonds.end();
1285 ++BondRunner) {
1286 if ((*BondRunner)->leftatom == *AtomRunner)
1287 LOG(2, " " << *(*BondRunner));
1288 }
1289 }
1290
1291 atom * CopyAtoms[FillerCount];
1292
1293 setVerbosity(4);
1294
1295 // calculate filler grid in [0,1]^3
1296 FillerDistance = MInverse * Vector(distance[0], distance[1], distance[2]);
1297 for(int i=0;i<NDIM;i++)
1298 N[i] = (int) ceil(1./FillerDistance[i]);
1299 LOG(1, "INFO: Grid steps are " << N[0] << ", " << N[1] << ", " << N[2] << ".");
1300
1301 // initialize seed of random number generator to current time
1302 RandomNumberGenerator &random = RandomNumberGeneratorFactory::getInstance().makeRandomNumberGenerator();
1303 const double rng_min = random.min();
1304 const double rng_max = random.max();
1305 //srand ( time(NULL) );
1306
1307 // go over [0,1]^3 filler grid
1308 for (n[0] = 0; n[0] < N[0]; n[0]++)
1309 for (n[1] = 0; n[1] < N[1]; n[1]++)
1310 for (n[2] = 0; n[2] < N[2]; n[2]++) {
1311 // calculate position of current grid vector in untransformed box
1312 CurrentPosition = M * Vector((double)n[0]/(double)N[0], (double)n[1]/(double)N[1], (double)n[2]/(double)N[2]);
1313 // create molecule random translation vector ...
1314 for (int i=0;i<NDIM;i++)
1315 FillerTranslations[i] = RandomMolDisplacement*(random()/((rng_max-rng_min)/2.) - 1.);
1316 LOG(1, "INFO: Current Position is " << CurrentPosition << "+" << FillerTranslations << ".");
1317
1318 // ... and rotation matrix
1319 if (DoRandomRotation)
1320 setRandomRotation(Rotations);
1321 else
1322 Rotations.setIdentity();
1323
1324
1325 // Check whether there is anything too close by and whether atom is outside of domain
1326 FillIt = true;
1327 for (std::map<molecule *, LinkedCell_deprecated *>::iterator ListRunner = LCList.begin(); ListRunner != LCList.end(); ++ListRunner) {
1328 // check whether its void
1329 FillIt = FillIt && isSpaceAroundPointVoid(
1330 ListRunner->second,
1331 (firstInsertion ? filler : NULL),
1332 boundary,
1333 CurrentPosition);
1334 if (!FillIt) {
1335 LOG(2, "REJECT: Position at " << Inserter << " is non-void.");
1336 break;
1337 }
1338 // check whether inside domain
1339 FillIt = FillIt && (Domain.isValid(CurrentPosition));
1340 if (!FillIt) {
1341 LOG(2, "REJECT: Position at " << CurrentPosition << " is "
1342 << distance << ", hence outside of domain.");
1343 break;
1344 }
1345 // check minimum distance to boundary
1346 const double distance = (Domain.DistanceToBoundary(CurrentPosition) - MinDistance);
1347 FillIt = FillIt && (distance > -MYEPSILON);
1348 if (!FillIt) {
1349 LOG(2, "REJECT: Position at " << CurrentPosition << " is " << distance << ", less than "
1350 << MinDistance << " hence, too close to boundary.");
1351 break;
1352 }
1353 }
1354 // Check whether point is in- or outside of tesselations
1355 if (FillIt) {
1356 for (MoleculeList::iterator ListRunner = MolList->ListOfMolecules.begin(); ListRunner != MolList->ListOfMolecules.end(); ListRunner++) {
1357 // get linked cell list
1358 if (TesselStruct[(*ListRunner)] != NULL) {
1359 const double distance = (TesselStruct[(*ListRunner)]->GetDistanceToSurface(Inserter, LCList[(*ListRunner)]));
1360 LOG(2, "INFO: Distance to surface is " << distance << ".");
1361 FillIt = FillIt && ((distance == -1.) || (distance > boundary)) && ((MaxSurfaceDistance < 0) || (MaxSurfaceDistance > distance));
1362 if (!FillIt) {
1363 LOG(2, "REJECT: Position at " << CurrentPosition << " is in distance of " << distance
1364 << " to a surface, less than " << MaxSurfaceDistance << " hence, too close.");
1365 break;
1366 }
1367 }
1368 }
1369 }
1370
1371 // insert into Filling
1372 if (FillIt) {
1373 Inserter = CurrentPosition + FillerTranslations;
1374 LOG(2, "ACCEPT: Position at " << CurrentPosition << " is void point.");
1375 // fill!
1376 Filling = filler->CopyMolecule();
1377 RandomizeMoleculePositions(Filling, RandomAtomDisplacement, Rotations, random);
1378 // translation
1379 Filling->Translate(&Inserter);
1380 // remove out-of-bounds atoms
1381 const bool status = RemoveAtomsOutsideDomain(Filling);
1382 if ((firstInsertion) && (!status)) { // no atom has been removed
1383 // remove copied atoms and molecule again
1384 Filling->removeAtomsinMolecule();
1385 World::getInstance().destroyMolecule(Filling);
1386 // and mark is final filler position
1387 Filling = filler;
1388 firstInsertion = false;
1389 firstInserter = Inserter;
1390 } else {
1391 // TODO: Remove when World has no MoleculeListClass anymore
1392 if (Filling)
1393 MolList->insert(Filling);
1394 }
1395 } else {
1396 LOG(2, "REJECT: Position at " << CurrentPosition << " is non-void point, within boundary or outside of MaxSurfaceDistance.");
[eee966]1397 continue;
1398 }
1399 }
[66fd49]1400
1401 // have we inserted any molecules?
1402 if (firstInsertion) {
1403 // If not remove filler
1404 for(molecule::iterator miter = filler->begin(); !filler->empty(); miter = filler->begin()) {
1405 atom *Walker = *miter;
1406 World::getInstance().destroyAtom(Walker);
1407 }
1408 World::getInstance().destroyMolecule(filler);
1409 } else {
1410 // otherwise translate and randomize to final position
1411 if (DoRandomRotation)
[b81f1c]1412 setRandomRotation(Rotations);
[66fd49]1413 else
1414 Rotations.setIdentity();
[a5028f]1415 RandomizeMoleculePositions(filler, RandomAtomDisplacement, Rotations, random);
[66fd49]1416 // translation
1417 filler->Translate(&firstInserter);
1418 // remove out-of-bounds atoms
1419 RemoveAtomsOutsideDomain(filler);
[eee966]1420 }
[66fd49]1421
[47d041]1422 LOG(0, MolList->ListOfMolecules.size() << " molecules have been inserted.");
[eee966]1423
[6bd7e0]1424 for (std::map<molecule *, LinkedCell_deprecated *>::iterator ListRunner = LCList.begin(); !LCList.empty(); ListRunner = LCList.begin()) {
[eee966]1425 delete ListRunner->second;
1426 LCList.erase(ListRunner);
1427 }
1428};
[8c54a3]1429
[6ac7ee]1430/** Tesselates the non convex boundary by rolling a virtual sphere along the surface of the molecule.
1431 * \param *out output stream for debugging
1432 * \param *mol molecule structure with Atom's and Bond's
[776b64]1433 * \param *&TesselStruct Tesselation filled with points, lines and triangles on boundary on return
[6bd7e0]1434 * \param *&LCList atoms in LinkedCell_deprecated list
[57066a]1435 * \param RADIUS radius of the virtual sphere
[6ac7ee]1436 * \param *filename filename prefix for output of vertex data
[4fc93f]1437 * \return true - tesselation successful, false - tesselation failed
[6ac7ee]1438 */
[6bd7e0]1439bool FindNonConvexBorder(molecule* const mol, Tesselation *&TesselStruct, const LinkedCell_deprecated *&LCList, const double RADIUS, const char *filename = NULL)
[03648b]1440{
[ce7bfd]1441 //Info FunctionInfo(__func__);
[3d919e]1442 bool freeLC = false;
[4fc93f]1443 bool status = false;
[6613ec]1444 CandidateForTesselation *baseline = NULL;
[1e168b]1445 bool OneLoopWithoutSuccessFlag = true; // marks whether we went once through all baselines without finding any without two triangles
[ad37ab]1446 bool TesselationFailFlag = false;
[357fba]1447
[a7b761b]1448 mol->getAtomCount();
[357fba]1449
[776b64]1450 if (TesselStruct == NULL) {
[47d041]1451 LOG(1, "Allocating Tesselation struct ...");
[776b64]1452 TesselStruct= new Tesselation;
[ef0e6d]1453 } else {
[776b64]1454 delete(TesselStruct);
[47d041]1455 LOG(1, "Re-Allocating Tesselation struct ...");
[776b64]1456 TesselStruct = new Tesselation;
[3d919e]1457 }
[ad37ab]1458
[57066a]1459 // initialise Linked Cell
[caa06ef]1460 PointCloudAdaptor< molecule > cloud(mol, mol->name);
[3d919e]1461 if (LCList == NULL) {
[6bd7e0]1462 LCList = new LinkedCell_deprecated(cloud, 2.*RADIUS);
[3d919e]1463 freeLC = true;
1464 }
1465
[57066a]1466 // 1. get starting triangle
[ce70970]1467 if (!TesselStruct->FindStartingTriangle(RADIUS, LCList)) {
[47d041]1468 ELOG(0, "No valid starting triangle found.");
[b5c2d7]1469 //performCriticalExit();
[ce70970]1470 }
[f8bd7d]1471 if (filename != NULL) {
1472 if ((DoSingleStepOutput && ((TesselStruct->TrianglesOnBoundary.size() % SingleStepWidth == 0)))) { // if we have a new triangle and want to output each new triangle configuration
[34c43a]1473 TesselStruct->Output(filename, cloud);
[f8bd7d]1474 }
1475 }
[3d919e]1476
[57066a]1477 // 2. expand from there
[1e168b]1478 while ((!TesselStruct->OpenLines.empty()) && (OneLoopWithoutSuccessFlag)) {
[b40a93]1479 (cerr << "There are " << TesselStruct->TrianglesOnBoundary.size() << " triangles and " << TesselStruct->OpenLines.size() << " open lines to scan for candidates." << endl);
1480 // 2a. print OpenLines without candidates
[47d041]1481 LOG(1, "There are the following open lines to scan for a candidates:");
[1e168b]1482 for (CandidateMap::iterator Runner = TesselStruct->OpenLines.begin(); Runner != TesselStruct->OpenLines.end(); Runner++)
[b40a93]1483 if (Runner->second->pointlist.empty())
[47d041]1484 LOG(1, " " << *(Runner->second));
[1e168b]1485
[734816]1486 // 2b. find best candidate for each OpenLine
[6613ec]1487 TesselationFailFlag = TesselStruct->FindCandidatesforOpenLines(RADIUS, LCList);
[3d919e]1488
[734816]1489 // 2c. print OpenLines with candidates again
[47d041]1490 LOG(1, "There are " << TesselStruct->OpenLines.size() << " open lines to scan for the best candidates:");
[1e168b]1491 for (CandidateMap::iterator Runner = TesselStruct->OpenLines.begin(); Runner != TesselStruct->OpenLines.end(); Runner++)
[47d041]1492 LOG(1, " " << *(Runner->second));
[1e168b]1493
[734816]1494 // 2d. search for smallest ShortestAngle among all candidates
1495 double ShortestAngle = 4.*M_PI;
[1e168b]1496 for (CandidateMap::iterator Runner = TesselStruct->OpenLines.begin(); Runner != TesselStruct->OpenLines.end(); Runner++) {
1497 if (Runner->second->ShortestAngle < ShortestAngle) {
1498 baseline = Runner->second;
1499 ShortestAngle = baseline->ShortestAngle;
[47d041]1500 LOG(1, "New best candidate is " << *baseline->BaseLine << " with point " << *(*baseline->pointlist.begin()) << " and angle " << baseline->ShortestAngle);
[1e168b]1501 }
1502 }
[734816]1503 // 2e. if we found one, add candidate
[f67b6e]1504 if ((ShortestAngle == 4.*M_PI) || (baseline->pointlist.empty()))
[7dea7c]1505 OneLoopWithoutSuccessFlag = false;
[1e168b]1506 else {
[474961]1507 TesselStruct->AddCandidatePolygon(*baseline, RADIUS, LCList);
[1e168b]1508 }
1509
[734816]1510 // 2f. write temporary envelope
[1e168b]1511 if (filename != NULL) {
1512 if ((DoSingleStepOutput && ((TesselStruct->TrianglesOnBoundary.size() % SingleStepWidth == 0)))) { // if we have a new triangle and want to output each new triangle configuration
[34c43a]1513 TesselStruct->Output(filename, cloud);
[1e168b]1514 }
[3d919e]1515 }
1516 }
[4fc93f]1517// // check envelope for consistency
1518// status = CheckListOfBaselines(TesselStruct);
1519//
1520// // look whether all points are inside of the convex envelope, otherwise add them via degenerated triangles
1521// //->InsertStraddlingPoints(mol, LCList);
[9879f6]1522// for (molecule::const_iterator iter = mol->begin(); iter != mol->end(); ++iter) {
[57066a]1523// class TesselPoint *Runner = NULL;
[9879f6]1524// Runner = *iter;
[47d041]1525// LOG(1, "Checking on " << Runner->Name << " ... ");
[e138de]1526// if (!->IsInnerPoint(Runner, LCList)) {
[47d041]1527// LOG(2, Runner->Name << " is outside of envelope, adding via degenerated triangles.");
[e138de]1528// ->AddBoundaryPointByDegeneratedTriangle(Runner, LCList);
[57066a]1529// } else {
[47d041]1530// LOG(2, Runner->Name << " is inside of or on envelope.");
[57066a]1531// }
1532// }
[357fba]1533
[f67b6e]1534// // Purges surplus triangles.
1535// TesselStruct->RemoveDegeneratedTriangles();
[b32dbb]1536//
1537// // check envelope for consistency
1538// status = CheckListOfBaselines(TesselStruct);
[b998c3]1539
[c72112]1540 cout << "before correction" << endl;
1541
[b998c3]1542 // store before correction
[c72112]1543 StoreTrianglesinFile(mol, TesselStruct, filename, "");
[b998c3]1544
[6613ec]1545// // correct degenerated polygons
1546// TesselStruct->CorrectAllDegeneratedPolygons();
1547//
[e69c87]1548 // check envelope for consistency
1549 status = CheckListOfBaselines(TesselStruct);
[ef0e6d]1550
[57066a]1551 // write final envelope
[e138de]1552 CalculateConcavityPerBoundaryPoint(TesselStruct);
[c72112]1553 cout << "after correction" << endl;
1554 StoreTrianglesinFile(mol, TesselStruct, filename, "");
[8c54a3]1555
[3d919e]1556 if (freeLC)
1557 delete(LCList);
[4fc93f]1558
1559 return status;
[6ac7ee]1560};
[03648b]1561
[57066a]1562
[ad37ab]1563/** Finds a hole of sufficient size in \a *mols to embed \a *srcmol into it.
[ca2587]1564 * \param *out output stream for debugging
[ad37ab]1565 * \param *mols molecules in the domain to embed in between
1566 * \param *srcmol embedding molecule
[ca2587]1567 * \return *Vector new center of \a *srcmol for embedding relative to \a this
1568 */
[e138de]1569Vector* FindEmbeddingHole(MoleculeListClass *mols, molecule *srcmol)
[ca2587]1570{
[ce7bfd]1571 //Info FunctionInfo(__func__);
[ca2587]1572 Vector *Center = new Vector;
1573 Center->Zero();
1574 // calculate volume/shape of \a *srcmol
1575
1576 // find embedding holes
1577
1578 // if more than one, let user choose
1579
1580 // return embedding center
1581 return Center;
1582};
1583
Note: See TracBrowser for help on using the repository browser.