Changeset 1cf5df


Ignore:
Timestamp:
Dec 17, 2009, 5:52:45 PM (16 years ago)
Author:
Frederik Heber <heber@…>
Branches:
Action_Thermostats, Add_AtomRandomPerturbation, Add_FitFragmentPartialChargesAction, Add_RotateAroundBondAction, Add_SelectAtomByNameAction, Added_ParseSaveFragmentResults, AddingActions_SaveParseParticleParameters, Adding_Graph_to_ChangeBondActions, Adding_MD_integration_tests, Adding_ParticleName_to_Atom, Adding_StructOpt_integration_tests, AtomFragments, Automaking_mpqc_open, AutomationFragmentation_failures, Candidate_v1.5.4, Candidate_v1.6.0, Candidate_v1.6.1, 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
Children:
1ca488f, 3930eb
Parents:
ebbd3d (diff), 73b510 (diff)
Note: this is a merge changeset, the changes displayed below correspond to the merge itself.
Use the (diff) links above to see all the changes relative to each parent.
Message:

Merge branch 'CorrectDegeneratedPolygons' into Analysis_PairCorrelation

Files:
4 added
27 edited

Legend:

Unmodified
Added
Removed
  • src/Makefile.am

    rebbd3d r1cf5df  
    55ANALYSISHEADER = analysis_bonds.hpp analysis_correlation.hpp
    66
    7 SOURCE = ${ANALYSISSOURCE} ${ATOMSOURCE} bond.cpp bondgraph.cpp boundary.cpp config.cpp element.cpp ellipsoid.cpp errorlogger.cpp graph.cpp helpers.cpp leastsquaremin.cpp linkedcell.cpp log.cpp logger.cpp memoryusageobserver.cpp moleculelist.cpp molecule.cpp molecule_dynamics.cpp molecule_fragmentation.cpp molecule_geometry.cpp molecule_graph.cpp molecule_pointcloud.cpp parser.cpp periodentafel.cpp tesselation.cpp tesselationhelpers.cpp vector.cpp verbose.cpp
    8 HEADER = ${ANALYSISHEADER} ${ATOMHEADER} bond.hpp bondgraph.hpp boundary.hpp config.hpp defs.hpp element.hpp ellipsoid.hpp errorlogger.hpp graph.hpp helpers.hpp leastsquaremin.hpp linkedcell.hpp lists.hpp log.hpp logger.hpp memoryallocator.hpp memoryusageobserver.hpp molecule.hpp molecule_template.hpp parser.hpp periodentafel.hpp stackclass.hpp tesselation.hpp tesselationhelpers.hpp vector.hpp verbose.hpp
     7SOURCE = ${ANALYSISSOURCE} ${ATOMSOURCE} bond.cpp bondgraph.cpp boundary.cpp config.cpp element.cpp ellipsoid.cpp errorlogger.cpp graph.cpp helpers.cpp info.cpp leastsquaremin.cpp linkedcell.cpp log.cpp logger.cpp memoryusageobserver.cpp moleculelist.cpp molecule.cpp molecule_dynamics.cpp molecule_fragmentation.cpp molecule_geometry.cpp molecule_graph.cpp molecule_pointcloud.cpp parser.cpp periodentafel.cpp tesselation.cpp tesselationhelpers.cpp vector.cpp verbose.cpp
     8HEADER = ${ANALYSISHEADER} ${ATOMHEADER} bond.hpp bondgraph.hpp boundary.hpp config.hpp defs.hpp element.hpp ellipsoid.hpp errorlogger.hpp graph.hpp helpers.hpp info.hpp leastsquaremin.hpp linkedcell.hpp lists.hpp log.hpp logger.hpp memoryallocator.hpp memoryusageobserver.hpp molecule.hpp molecule_template.hpp parser.hpp periodentafel.hpp stackclass.hpp tesselation.hpp tesselationhelpers.hpp vector.hpp verbose.hpp
    99
    1010BOOST_LIB = $(BOOST_LDFLAGS) $(BOOST_MPL_LIB)
     
    2525
    2626#EXTRA_DIST = ${molecuilder_DATA}
     27
     28FORCE:
     29$(srcdir)/.git-version: FORCE
     30        @if (test -d $(top_srcdir)/../.git && cd $(srcdir) && git describe HEAD) > .git-version-t 2>/dev/null \
     31          && ! diff .git-version-t $(srcdir)/.git-version >/dev/null 2>&1; then \
     32          mv -f .git-version-t $(srcdir)/.git-version; \
     33        else \
     34          rm -f .git-version-t; \
     35        fi
     36
     37EXTRA_DIST = $(srcdir)/.git-version
     38
     39$(srcdir)/version.c: $(srcdir)/.git-version
     40        echo "const char *ESPACKVersion = \"$(PACKAGE_NAME) -- git version: "`cat $(srcdir)/.git-version`"\";" > $@
     41
     42molecuilder_SOURCES += $(srcdir)/version.c
  • src/bondgraph.cpp

    rebbd3d r1cf5df  
    3535/** Parses the bond lengths in a given file and puts them int a matrix form.
    3636 * Allocates \a MatrixContainer for BondGraph::BondLengthMatrix, using MatrixContainer::ParseMatrix(),
    37  * but only if parsing is successfull. Otherwise variable is left as NULL.
     37 * but only if parsing is successful. Otherwise variable is left as NULL.
    3838 * \param *out output stream for debugging
    3939 * \param filename file with bond lengths to parse
  • src/boundary.cpp

    rebbd3d r1cf5df  
    1010#include "element.hpp"
    1111#include "helpers.hpp"
     12#include "info.hpp"
    1213#include "linkedcell.hpp"
    1314#include "log.hpp"
     
    3334double *GetDiametersOfCluster(const Boundaries *BoundaryPtr, const molecule *mol, Tesselation *&TesselStruct, const bool IsAngstroem)
    3435{
     36        Info FunctionInfo(__func__);
    3537  // get points on boundary of NULL was given as parameter
    3638  bool BoundaryFreeFlag = false;
     
    5355  } else {
    5456    BoundaryPoints = BoundaryPtr;
    55     Log() << Verbose(1) << "Using given boundary points set." << endl;
     57    Log() << Verbose(0) << "Using given boundary points set." << endl;
    5658  }
    5759  // determine biggest "diameter" of cluster for each axis
     
    6769          //Log() << Verbose(1) << "Current component is " << component << ", Othercomponent is " << Othercomponent << "." << endl;
    6870          for (Boundaries::const_iterator runner = BoundaryPoints[axis].begin(); runner != BoundaryPoints[axis].end(); runner++) {
    69               //Log() << Verbose(2) << "Current runner is " << *(runner->second.second) << "." << endl;
     71              //Log() << Verbose(1) << "Current runner is " << *(runner->second.second) << "." << endl;
    7072              // seek for the neighbours pair where the Othercomponent sign flips
    7173              Neighbour = runner;
     
    8284                  DistanceVector.CopyVector(&runner->second.second->x);
    8385                  DistanceVector.SubtractVector(&Neighbour->second.second->x);
    84                   //Log() << Verbose(3) << "OldComponent is " << OldComponent << ", new one is " << DistanceVector.x[Othercomponent] << "." << endl;
     86                  //Log() << Verbose(2) << "OldComponent is " << OldComponent << ", new one is " << DistanceVector.x[Othercomponent] << "." << endl;
    8587                } while ((runner != Neighbour) && (fabs(OldComponent / fabs(
    8688                  OldComponent) - DistanceVector.x[Othercomponent] / fabs(
     
    9193                    OtherNeighbour = BoundaryPoints[axis].end();
    9294                  OtherNeighbour--;
    93                   //Log() << Verbose(2) << "The pair, where the sign of OtherComponent flips, is: " << *(Neighbour->second.second) << " and " << *(OtherNeighbour->second.second) << "." << endl;
     95                  //Log() << Verbose(1) << "The pair, where the sign of OtherComponent flips, is: " << *(Neighbour->second.second) << " and " << *(OtherNeighbour->second.second) << "." << endl;
    9496                  // now we have found the pair: Neighbour and OtherNeighbour
    9597                  OtherVector.CopyVector(&runner->second.second->x);
    9698                  OtherVector.SubtractVector(&OtherNeighbour->second.second->x);
    97                   //Log() << Verbose(2) << "Distances to Neighbour and OtherNeighbour are " << DistanceVector.x[component] << " and " << OtherVector.x[component] << "." << endl;
    98                   //Log() << Verbose(2) << "OtherComponents to Neighbour and OtherNeighbour are " << DistanceVector.x[Othercomponent] << " and " << OtherVector.x[Othercomponent] << "." << endl;
     99                  //Log() << Verbose(1) << "Distances to Neighbour and OtherNeighbour are " << DistanceVector.x[component] << " and " << OtherVector.x[component] << "." << endl;
     100                  //Log() << Verbose(1) << "OtherComponents to Neighbour and OtherNeighbour are " << DistanceVector.x[Othercomponent] << " and " << OtherVector.x[Othercomponent] << "." << endl;
    99101                  // do linear interpolation between points (is exact) to extract exact intersection between Neighbour and OtherNeighbour
    100102                  w1 = fabs(OtherVector.x[Othercomponent]);
     
    103105                      * OtherVector.x[component]) / (w1 + w2));
    104106                  // mark if it has greater diameter
    105                   //Log() << Verbose(2) << "Comparing current greatest " << GreatestDiameter[component] << " to new " << tmp << "." << endl;
     107                  //Log() << Verbose(1) << "Comparing current greatest " << GreatestDiameter[component] << " to new " << tmp << "." << endl;
    106108                  GreatestDiameter[component] = (GreatestDiameter[component]
    107109                      > tmp) ? GreatestDiameter[component] : tmp;
    108110                } //else
    109               //Log() << Verbose(2) << "Saw no sign flip, probably top or bottom node." << endl;
     111              //Log() << Verbose(1) << "Saw no sign flip, probably top or bottom node." << endl;
    110112            }
    111113        }
     
    135137Boundaries *GetBoundaryPoints(const molecule *mol, Tesselation *&TesselStruct)
    136138{
     139        Info FunctionInfo(__func__);
    137140  atom *Walker = NULL;
    138141  PointMap PointsOnBoundary;
     
    149152  double angle = 0.;
    150153
    151   Log() << Verbose(1) << "Finding all boundary points." << endl;
    152154  // 3a. Go through every axis
    153155  for (int axis = 0; axis < NDIM; axis++) {
     
    176178        angle = 0.; // otherwise it's a vector in Axis Direction and unimportant for boundary issues
    177179
    178       //Log() << Verbose(2) << "Checking sign in quadrant : " << ProjectedVector.Projection(&AngleReferenceNormalVector) << "." << endl;
     180      //Log() << Verbose(1) << "Checking sign in quadrant : " << ProjectedVector.Projection(&AngleReferenceNormalVector) << "." << endl;
    179181      if (ProjectedVector.ScalarProduct(&AngleReferenceNormalVector) > 0) {
    180182        angle = 2. * M_PI - angle;
    181183      }
    182       Log() << Verbose(2) << "Inserting " << *Walker << ": (r, alpha) = (" << radius << "," << angle << "): " << ProjectedVector << endl;
     184      Log() << Verbose(1) << "Inserting " << *Walker << ": (r, alpha) = (" << radius << "," << angle << "): " << ProjectedVector << endl;
    183185      BoundaryTestPair = BoundaryPoints[axis].insert(BoundariesPair(angle, DistancePair (radius, Walker)));
    184186      if (!BoundaryTestPair.second) { // same point exists, check first r, then distance of original vectors to center of gravity
     
    210212    // printing all inserted for debugging
    211213    //    {
    212     //      Log() << Verbose(2) << "Printing list of candidates for axis " << axis << " which we have inserted so far." << endl;
     214    //      Log() << Verbose(1) << "Printing list of candidates for axis " << axis << " which we have inserted so far." << endl;
    213215    //      int i=0;
    214216    //      for(Boundaries::iterator runner = BoundaryPoints[axis].begin(); runner != BoundaryPoints[axis].end(); runner++) {
    215217    //        if (runner != BoundaryPoints[axis].begin())
    216     //          Log() << Verbose(2) << ", " << i << ": " << *runner->second.second;
     218    //          Log() << Verbose(0) << ", " << i << ": " << *runner->second.second;
    217219    //        else
    218     //          Log() << Verbose(2) << i << ": " << *runner->second.second;
     220    //          Log() << Verbose(0) << i << ": " << *runner->second.second;
    219221    //        i++;
    220222    //      }
    221     //      Log() << Verbose(2) << endl;
     223    //      Log() << Verbose(0) << endl;
    222224    //    }
    223225    // 3c. throw out points whose distance is less than the mean of left and right neighbours
     
    249251          SideA.SubtractVector(MolCenter);
    250252          SideA.ProjectOntoPlane(&AxisVector);
    251           //          Log() << Verbose(0) << "SideA: " << SideA << endl;
     253          //          Log() << Verbose(1) << "SideA: " << SideA << endl;
    252254
    253255          SideB.CopyVector(&right->second.second->x);
    254256          SideB.SubtractVector(MolCenter);
    255257          SideB.ProjectOntoPlane(&AxisVector);
    256           //          Log() << Verbose(0) << "SideB: " << SideB << endl;
     258          //          Log() << Verbose(1) << "SideB: " << SideB << endl;
    257259
    258260          SideC.CopyVector(&left->second.second->x);
    259261          SideC.SubtractVector(&right->second.second->x);
    260262          SideC.ProjectOntoPlane(&AxisVector);
    261           //          Log() << Verbose(0) << "SideC: " << SideC << endl;
     263          //          Log() << Verbose(1) << "SideC: " << SideC << endl;
    262264
    263265          SideH.CopyVector(&runner->second.second->x);
    264266          SideH.SubtractVector(MolCenter);
    265267          SideH.ProjectOntoPlane(&AxisVector);
    266           //          Log() << Verbose(0) << "SideH: " << SideH << endl;
     268          //          Log() << Verbose(1) << "SideH: " << SideH << endl;
    267269
    268270          // calculate each length
     
    277279          const double delta = SideC.Angle(&SideH);
    278280          const double MinDistance = a * sin(beta) / (sin(delta)) * (((alpha < M_PI / 2.) || (gamma < M_PI / 2.)) ? 1. : -1.);
    279           //Log() << Verbose(2) << " 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 << "." << endl;
     281          //Log() << Verbose(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 << "." << endl;
    280282          Log() << Verbose(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 << "." << endl;
    281283          if ((fabs(h / fabs(h) - MinDistance / fabs(MinDistance)) < MYEPSILON) && ((h - MinDistance)) < -MYEPSILON) {
     
    303305void FindConvexBorder(const molecule* mol, Tesselation *&TesselStruct, const LinkedCell *LCList, const char *filename)
    304306{
     307        Info FunctionInfo(__func__);
    305308  bool BoundaryFreeFlag = false;
    306309  Boundaries *BoundaryPoints = NULL;
    307 
    308   Log() << Verbose(1) << "Begin of FindConvexBorder" << endl;
    309310
    310311  if (TesselStruct != NULL) // free if allocated
     
    317318      BoundaryPoints = GetBoundaryPoints(mol, TesselStruct);
    318319  } else {
    319       Log() << Verbose(1) << "Using given boundary points set." << endl;
     320      Log() << Verbose(0) << "Using given boundary points set." << endl;
    320321  }
    321322
     
    323324  for (int axis=0; axis < NDIM; axis++)
    324325    {
    325       Log() << Verbose(2) << "Printing list of candidates for axis " << axis << " which we have inserted so far." << endl;
     326      Log() << Verbose(1) << "Printing list of candidates for axis " << axis << " which we have inserted so far." << endl;
    326327      int i=0;
    327328      for(Boundaries::iterator runner = BoundaryPoints[axis].begin(); runner != BoundaryPoints[axis].end(); runner++) {
    328329        if (runner != BoundaryPoints[axis].begin())
    329           Log() << Verbose(2) << ", " << i << ": " << *runner->second.second;
     330          Log() << Verbose(0) << ", " << i << ": " << *runner->second.second;
    330331        else
    331           Log() << Verbose(2) << i << ": " << *runner->second.second;
     332          Log() << Verbose(0) << i << ": " << *runner->second.second;
    332333        i++;
    333334      }
    334       Log() << Verbose(2) << endl;
     335      Log() << Verbose(0) << endl;
    335336    }
    336337
     
    341342          eLog() << Verbose(2) << "Point " << *(runner->second.second) << " is already present!" << endl;
    342343
    343   Log() << Verbose(2) << "I found " << TesselStruct->PointsOnBoundaryCount << " points on the convex boundary." << endl;
     344  Log() << Verbose(0) << "I found " << TesselStruct->PointsOnBoundaryCount << " points on the convex boundary." << endl;
    344345  // now we have the whole set of edge points in the BoundaryList
    345346
     
    347348  //  Log() << Verbose(1) << "Listing PointsOnBoundary:";
    348349  //  for(PointMap::iterator runner = PointsOnBoundary.begin(); runner != PointsOnBoundary.end(); runner++) {
    349   //    Log() << Verbose(1) << " " << *runner->second;
     350  //    Log() << Verbose(0) << " " << *runner->second;
    350351  //  }
    351   //  Log() << Verbose(1) << endl;
     352  //  Log() << Verbose(0) << endl;
    352353
    353354  // 3a. guess starting triangle
     
    359360  // 3c. check whether all atoms lay inside the boundary, if not, add to boundary points, segment triangle into three with the new point
    360361  if (!TesselStruct->InsertStraddlingPoints(mol, LCList))
    361     Log() << Verbose(1) << "Insertion of straddling points failed!" << endl;
    362 
    363   Log() << Verbose(2) << "I created " << TesselStruct->TrianglesOnBoundary.size() << " intermediate triangles with " << TesselStruct->LinesOnBoundary.size() << " lines and " << TesselStruct->PointsOnBoundary.size() << " points." << endl;
     362    eLog() << Verbose(1) << "Insertion of straddling points failed!" << endl;
     363
     364  Log() << Verbose(0) << "I created " << TesselStruct->TrianglesOnBoundary.size() << " intermediate triangles with " << TesselStruct->LinesOnBoundary.size() << " lines and " << TesselStruct->PointsOnBoundary.size() << " points." << endl;
    364365
    365366  // 4. Store triangles in tecplot file
     
    411412//    Log() << Verbose(1) << "Correction of concave tesselpoints failed!" << endl;
    412413
    413   Log() << Verbose(2) << "I created " << TesselStruct->TrianglesOnBoundary.size() << " triangles with " << TesselStruct->LinesOnBoundary.size() << " lines and " << TesselStruct->PointsOnBoundary.size() << " points." << endl;
     414  Log() << Verbose(0) << "I created " << TesselStruct->TrianglesOnBoundary.size() << " triangles with " << TesselStruct->LinesOnBoundary.size() << " lines and " << TesselStruct->PointsOnBoundary.size() << " points." << endl;
    414415
    415416  // 4. Store triangles in tecplot file
     
    437438  if (BoundaryFreeFlag)
    438439    delete[] (BoundaryPoints);
    439 
    440   Log() << Verbose(1) << "End of FindConvexBorder" << endl;
    441440};
    442441
     
    450449bool RemoveAllBoundaryPoints(class Tesselation *&TesselStruct, const molecule * const mol, const char * const filename)
    451450{
     451        Info FunctionInfo(__func__);
    452452  int i=0;
    453453  char number[MAXSTRINGSIZE];
     
    460460  PointMap::iterator PointRunner;
    461461  while (!TesselStruct->PointsOnBoundary.empty()) {
    462     Log() << Verbose(2) << "Remaining points are: ";
     462    Log() << Verbose(1) << "Remaining points are: ";
    463463    for (PointMap::iterator PointSprinter = TesselStruct->PointsOnBoundary.begin(); PointSprinter != TesselStruct->PointsOnBoundary.end(); PointSprinter++)
    464       Log() << Verbose(2) << *(PointSprinter->second) << "\t";
    465     Log() << Verbose(2) << endl;
     464      Log() << Verbose(0) << *(PointSprinter->second) << "\t";
     465    Log() << Verbose(0) << endl;
    466466
    467467    PointRunner = TesselStruct->PointsOnBoundary.begin();
     
    503503double ConvexizeNonconvexEnvelope(class Tesselation *&TesselStruct, const molecule * const mol, const char * const filename)
    504504{
     505        Info FunctionInfo(__func__);
    505506  double volume = 0;
    506507  class BoundaryPointSet *point = NULL;
     
    516517  int run = 0;
    517518
    518   Log() << Verbose(0) << "Begin of ConvexizeNonconvexEnvelope" << endl;
    519 
    520519  // check whether there is something to work on
    521520  if (TesselStruct == NULL) {
     
    539538      for (LineMap::iterator LineRunner = point->lines.begin(); LineRunner != point->lines.end(); LineRunner++) {
    540539        line = LineRunner->second;
    541         Log() << Verbose(2) << "INFO: Current line of point " << *point << " is " << *line << "." << endl;
     540        Log() << Verbose(1) << "INFO: Current line of point " << *point << " is " << *line << "." << endl;
    542541        if (!line->CheckConvexityCriterion()) {
    543542          // remove the point if needed
     
    604603
    605604  // end
    606   Log() << Verbose(1) << "Volume is " << volume << "." << endl;
    607   Log() << Verbose(0) << "End of ConvexizeNonconvexEnvelope" << endl;
     605  Log() << Verbose(0) << "Volume is " << volume << "." << endl;
    608606  return volume;
    609607};
     
    619617double VolumeOfConvexEnvelope(class Tesselation *TesselStruct, class config *configuration)
    620618{
     619        Info FunctionInfo(__func__);
    621620  bool IsAngstroem = configuration->GetIsAngstroem();
    622621  double volume = 0.;
     
    625624
    626625  // 6a. Every triangle forms a pyramid with the center of gravity as its peak, sum up the volumes
    627   Log() << Verbose(1)
    628       << "Calculating the volume of the pyramids formed out of triangles and center of gravity."
    629       << endl;
    630626  for (TriangleMap::iterator runner = TesselStruct->TrianglesOnBoundary.begin(); runner != TesselStruct->TrianglesOnBoundary.end(); runner++)
    631627    { // go through every triangle, calculate volume of its pyramid with CoG as peak
     
    642638      const double h = x.Norm(); // distance of CoG to triangle
    643639      const double PyramidVolume = (1. / 3.) * G * h; // this formula holds for _all_ pyramids (independent of n-edge base or (not) centered peak)
    644       Log() << Verbose(2) << "Area of triangle is " << setprecision(10) << G << " "
     640      Log() << Verbose(1) << "Area of triangle is " << setprecision(10) << G << " "
    645641          << (IsAngstroem ? "angstrom" : "atomiclength") << "^2, height is "
    646642          << h << " and the volume is " << PyramidVolume << " "
     
    664660void StoreTrianglesinFile(const molecule * const mol, const Tesselation *&TesselStruct, const char *filename, const char *extraSuffix)
    665661{
     662        Info FunctionInfo(__func__);
    666663  // 4. Store triangles in tecplot file
    667664  if (filename != NULL) {
     
    698695void PrepareClustersinWater(config *configuration, molecule *mol, double ClusterVolume, double celldensity)
    699696{
     697        Info FunctionInfo(__func__);
    700698  bool IsAngstroem = true;
    701699  double *GreatestDiameter = NULL;
     
    798796molecule * FillBoxWithMolecule(MoleculeListClass *List, molecule *filler, config &configuration, double distance[NDIM], double RandomAtomDisplacement, double RandomMolDisplacement, bool DoRandomRotation)
    799797{
     798        Info FunctionInfo(__func__);
    800799  molecule *Filling = new molecule(filler->elemente);
    801800  Vector CurrentPosition;
     
    814813  double phi[NDIM];
    815814  class Tesselation *TesselStruct[List->ListOfMolecules.size()];
    816 
    817   Log() << Verbose(0) << "Begin of FillBoxWithMolecule" << endl;
    818815
    819816  i=0;
     
    877874          for (int i=0;i<NDIM;i++)
    878875            FillerTranslations.x[i] = RandomMolDisplacement*(rand()/(RAND_MAX/2.) - 1.);
    879           Log() << Verbose(3) << "INFO: Translating this filler by " << FillerTranslations << "." << endl;
     876          Log() << Verbose(2) << "INFO: Translating this filler by " << FillerTranslations << "." << endl;
    880877
    881878          // go through all atoms
     
    938935        delete(TesselStruct[i]);
    939936  }
    940   Log() << Verbose(0) << "End of FillBoxWithMolecule" << endl;
    941 
    942937  return Filling;
    943938};
     
    951946 * \param RADIUS radius of the virtual sphere
    952947 * \param *filename filename prefix for output of vertex data
    953  */
    954 void FindNonConvexBorder(const molecule* const mol, Tesselation *&TesselStruct, const LinkedCell *&LCList, const double RADIUS, const char *filename = NULL)
     948 * \return true - tesselation successful, false - tesselation failed
     949 */
     950bool FindNonConvexBorder(const molecule* const mol, Tesselation *&TesselStruct, const LinkedCell *&LCList, const double RADIUS, const char *filename = NULL)
    955951{
     952        Info FunctionInfo(__func__);
    956953  bool freeLC = false;
    957   LineMap::iterator baseline;
     954  bool status = false;
     955  CandidateForTesselation *baseline;
    958956  LineMap::iterator testline;
    959   bool OneLoopWithoutSuccessFlag = false;  // marks whether we went once through all baselines without finding any without two triangles
     957  bool OneLoopWithoutSuccessFlag = true;  // marks whether we went once through all baselines without finding any without two triangles
    960958  bool TesselationFailFlag = false;
    961 
    962   Log() << Verbose(1) << "Entering search for non convex hull. " << endl;
     959  BoundaryTriangleSet *T = NULL;
     960
    963961  if (TesselStruct == NULL) {
    964962    Log() << Verbose(1) << "Allocating Tesselation struct ..." << endl;
     
    970968  }
    971969
    972   Log() << Verbose(0) << "Begin of FindNonConvexBorder\n";
    973 
    974970  // initialise Linked Cell
    975971  if (LCList == NULL) {
     
    982978
    983979  // 2. expand from there
    984   baseline = TesselStruct->LinesOnBoundary.begin();
    985   baseline++; // skip first line
    986   while ((baseline != TesselStruct->LinesOnBoundary.end()) || (OneLoopWithoutSuccessFlag)) {
    987     if (baseline->second->triangles.size() == 1) {
    988       CheckListOfBaselines(TesselStruct);
    989       // 3. find next triangle
    990       TesselationFailFlag = TesselStruct->FindNextSuitableTriangle(*(baseline->second), *(((baseline->second->triangles.begin()))->second), RADIUS, LCList); //the line is there, so there is a triangle, but only one.
    991       OneLoopWithoutSuccessFlag = OneLoopWithoutSuccessFlag || TesselationFailFlag;
    992       if (!TesselationFailFlag)
    993         eLog() << Verbose(2) << "FindNextSuitableTriangle failed." << endl;
    994 
    995       // write temporary envelope
    996       if (filename != NULL) {
    997         if ((DoSingleStepOutput && ((TesselStruct->TrianglesOnBoundary.size() % SingleStepWidth == 0)))) { // if we have a new triangle and want to output each new triangle configuration
    998           TesselStruct->Output(filename, mol);
    999         }
     980  while ((!TesselStruct->OpenLines.empty()) && (OneLoopWithoutSuccessFlag)) {
     981    // 2a. fill all new OpenLines
     982    Log() << Verbose(1) << "There are " << TesselStruct->OpenLines.size() << " open lines to scan for candidates:" << endl;
     983    for (CandidateMap::iterator Runner = TesselStruct->OpenLines.begin(); Runner != TesselStruct->OpenLines.end(); Runner++)
     984      Log() << Verbose(2) << *(Runner->second) << endl;
     985
     986    for (CandidateMap::iterator Runner = TesselStruct->OpenLines.begin(); Runner != TesselStruct->OpenLines.end(); Runner++) {
     987      baseline = Runner->second;
     988      if (baseline->pointlist.empty()) {
     989        T = (((baseline->BaseLine->triangles.begin()))->second);
     990        Log() << Verbose(1) << "Finding best candidate for open line " << *baseline->BaseLine << " of triangle " << *T << endl;
     991        TesselationFailFlag = TesselStruct->FindNextSuitableTriangle(*baseline, *T, RADIUS, LCList); //the line is there, so there is a triangle, but only one.
    1000992      }
    1001       if (TesselationFailFlag) {
    1002         baseline = TesselStruct->LinesOnBoundary.begin();
    1003         OneLoopWithoutSuccessFlag = false;
    1004         Log() << Verbose(2) << "Baseline set to begin." << endl;
     993    }
     994
     995    // 2b. search for smallest ShortestAngle among all candidates
     996    double ShortestAngle = 4.*M_PI;
     997    Log() << Verbose(1) << "There are " << TesselStruct->OpenLines.size() << " open lines to scan for the best candidates:" << endl;
     998    for (CandidateMap::iterator Runner = TesselStruct->OpenLines.begin(); Runner != TesselStruct->OpenLines.end(); Runner++)
     999      Log() << Verbose(2) << *(Runner->second) << endl;
     1000
     1001    for (CandidateMap::iterator Runner = TesselStruct->OpenLines.begin(); Runner != TesselStruct->OpenLines.end(); Runner++) {
     1002      if (Runner->second->ShortestAngle < ShortestAngle) {
     1003        baseline = Runner->second;
     1004        ShortestAngle = baseline->ShortestAngle;
     1005        //Log() << Verbose(1) << "New best candidate is " << *baseline->BaseLine << " with point " << *baseline->point << " and angle " << baseline->ShortestAngle << endl;
    10051006      }
    1006     } else {
    1007       //Log() << Verbose(1) << "Line " << *baseline->second << " has " << baseline->second->triangles.size() << " triangles adjacent" << endl;
    1008       if (baseline->second->triangles.size() != 2) {
    1009         eLog() << Verbose(0) << "TESSELATION FINISHED WITH INVALID TRIANGLE COUNT!" << endl;
    1010         performCriticalExit();
     1007    }
     1008    if ((ShortestAngle == 4.*M_PI) || (baseline->pointlist.empty()))
     1009      OneLoopWithoutSuccessFlag = false;
     1010    else {
     1011      TesselStruct->AddCandidateTriangle(*baseline);
     1012    }
     1013
     1014    // write temporary envelope
     1015    if (filename != NULL) {
     1016      if ((DoSingleStepOutput && ((TesselStruct->TrianglesOnBoundary.size() % SingleStepWidth == 0)))) { // if we have a new triangle and want to output each new triangle configuration
     1017        TesselStruct->Output(filename, mol);
    10111018      }
    10121019    }
    1013 
    1014     if ((baseline == TesselStruct->LinesOnBoundary.end()) && (OneLoopWithoutSuccessFlag)) {
    1015       baseline = TesselStruct->LinesOnBoundary.begin();   // restart if we reach end due to newly inserted lines
    1016       OneLoopWithoutSuccessFlag = false;
    1017     }
    1018     baseline++;
    1019   }
    1020   // check envelope for consistency
    1021   CheckListOfBaselines(TesselStruct);
    1022 
    1023   // look whether all points are inside of the convex envelope, otherwise add them via degenerated triangles
    1024   //->InsertStraddlingPoints(mol, LCList);
     1020  }
     1021//  // check envelope for consistency
     1022//  status = CheckListOfBaselines(TesselStruct);
     1023//
     1024//  // look whether all points are inside of the convex envelope, otherwise add them via degenerated triangles
     1025//  //->InsertStraddlingPoints(mol, LCList);
    10251026//  mol->GoToFirst();
    10261027//  class TesselPoint *Runner = NULL;
     
    10371038//  }
    10381039
    1039   // Purges surplus triangles.
    1040   TesselStruct->RemoveDegeneratedTriangles();
     1040//  // Purges surplus triangles.
     1041//  TesselStruct->RemoveDegeneratedTriangles();
    10411042
    10421043  // check envelope for consistency
    1043   CheckListOfBaselines(TesselStruct);
     1044  status = CheckListOfBaselines(TesselStruct);
     1045
     1046  // store before correction
     1047  StoreTrianglesinFile(mol, (const Tesselation *&)TesselStruct, filename, "");
     1048
     1049  // correct degenerated polygons
     1050  TesselStruct->CorrectAllDegeneratedPolygons();
     1051
     1052  // check envelope for consistency
     1053  status = CheckListOfBaselines(TesselStruct);
    10441054
    10451055  // write final envelope
     
    10491059  if (freeLC)
    10501060    delete(LCList);
    1051   Log() << Verbose(0) << "End of FindNonConvexBorder\n";
     1061
     1062  return status;
    10521063};
    10531064
     
    10611072Vector* FindEmbeddingHole(MoleculeListClass *mols, molecule *srcmol)
    10621073{
     1074        Info FunctionInfo(__func__);
    10631075  Vector *Center = new Vector;
    10641076  Center->Zero();
  • src/boundary.hpp

    rebbd3d r1cf5df  
    3535
    3636#define DEBUG 1
    37 #define DoSingleStepOutput 1
    38 #define SingleStepWidth 1
     37#define DoSingleStepOutput 0
     38#define SingleStepWidth 10
    3939
    4040#define DistancePair pair < double, atom* >
     
    5353Vector* FindEmbeddingHole(MoleculeListClass *mols, molecule *srcmol);
    5454void FindNextSuitablePoint(class BoundaryTriangleSet *BaseTriangle, class BoundaryLineSet *BaseLine, atom*& OptCandidate, Vector *OptCandidateCenter, double *ShortestAngle, const double RADIUS, LinkedCell *LC);
    55 void FindNonConvexBorder(const molecule* const mol, Tesselation *&TesselStruct, const LinkedCell *&LC, const double RADIUS, const char *tempbasename);
     55bool FindNonConvexBorder(const molecule* const mol, Tesselation *&TesselStruct, const LinkedCell *&LC, const double RADIUS, const char *tempbasename);
    5656Boundaries *GetBoundaryPoints(const molecule *mol, Tesselation *&TesselStruct);
    5757double * GetDiametersOfCluster(const Boundaries *BoundaryPtr, const molecule *mol, Tesselation *&TesselStruct, const bool IsAngstroem);
  • src/builder.cpp

    rebbd3d r1cf5df  
    6565#include "molecule.hpp"
    6666#include "periodentafel.hpp"
     67#include "version.h"
    6768
    6869/********************************************* Subsubmenu routine ************************************/
     
    15741575                else {
    15751576                  Log() << Verbose(2) << "File found and parsed." << endl;
    1576                   mol->SetNameFromFilename(argv[argptr]);
    1577                   molecules->ListOfMolecules.remove(mol);
    1578                   molecules->DissectMoleculeIntoConnectedSubgraphs(mol,&configuration);
    1579                   if (molecules->ListOfMolecules.size() != 0) {
    1580                     for (MoleculeList::iterator ListRunner = molecules->ListOfMolecules.begin(); ListRunner != molecules->ListOfMolecules.end(); ListRunner++)
    1581                       if ((*ListRunner)->ActiveFlag) {
    1582                         mol = *ListRunner;
    1583                         break;
    1584                       }
    1585                   }
     1577                  // @TODO rather do the dissection afterwards
     1578//                  mol->SetNameFromFilename(argv[argptr]);
     1579//                  molecules->ListOfMolecules.remove(mol);
     1580//                  molecules->DissectMoleculeIntoConnectedSubgraphs(mol,&configuration);
     1581//                  delete(mol);
     1582//                  if (molecules->ListOfMolecules.size() != 0) {
     1583//                    for (MoleculeList::iterator ListRunner = molecules->ListOfMolecules.begin(); ListRunner != molecules->ListOfMolecules.end(); ListRunner++)
     1584//                      if ((*ListRunner)->ActiveFlag) {
     1585//                        mol = *ListRunner;
     1586//                        break;
     1587//                      }
     1588//                  }
    15861589                  configPresent = present;
    15871590                }
     
    18021805                start = clock();
    18031806                LCList = new LinkedCell(Boundary, atof(argv[argptr])*2.);
    1804                 FindNonConvexBorder(Boundary, T, LCList, atof(argv[argptr]), argv[argptr+1]);
     1807                if (!FindNonConvexBorder(Boundary, T, LCList, atof(argv[argptr]), argv[argptr+1]))
     1808                  ExitFlag = 255;
    18051809                //FindDistributionOfEllipsoids(T, &LCList, N, number, filename.c_str());
    18061810                end = clock();
    18071811                Log() << Verbose(0) << "Clocks for this operation: " << (end-start) << ", time: " << ((double)(end-start)/CLOCKS_PER_SEC) << "s." << endl;
    18081812                delete(LCList);
     1813                delete(T);
    18091814                argptr+=2;
    18101815              }
     
    21022107                if (volume != -1)
    21032108                  ExitFlag = 255;
    2104                   eLog() << Verbose(0) << "Not enough arguments given for suspension: -u <density>" << endl;
     2109                  eLog() << Verbose(0) << "Not enough or invalid arguments given for suspension: -u <density>" << endl;
    21052110                  performCriticalExit();
    21062111              } else {
     
    22182223  int j;
    22192224
     2225  cout << ESPACKVersion << endl;
     2226
    22202227  setVerbosity(0);
    22212228
  • src/config.cpp

    rebbd3d r1cf5df  
    140140void ConfigFileBuffer::MapIonTypesInBuffer(const int NoAtoms)
    141141{
    142   map<const char *, int, IonTypeCompare> LineList;
     142  map<const char *, int, IonTypeCompare> IonTypeLineMap;
    143143  if (LineMapping == NULL) {
    144144    eLog() << Verbose(0) << "map pointer is NULL: " << LineMapping << endl;
     
    149149  // put all into hashed map
    150150  for (int i=0; i<NoAtoms; ++i) {
    151     LineList.insert(pair<const char *, int> (buffer[CurrentLine+i], CurrentLine+i));
     151    IonTypeLineMap.insert(pair<const char *, int> (buffer[CurrentLine+i], CurrentLine+i));
    152152  }
    153153
    154154  // fill map
    155155  int nr=0;
    156   for (map<const char *, int, IonTypeCompare>::iterator runner = LineList.begin(); runner != LineList.end(); ++runner) {
     156  for (map<const char *, int, IonTypeCompare>::iterator runner = IonTypeLineMap.begin(); runner != IonTypeLineMap.end(); ++runner) {
    157157    if (CurrentLine+nr < NoLines)
    158158      LineMapping[CurrentLine+(nr++)] = runner->second;
     
    10691069  mol->SetNameFromFilename(filename);
    10701070  mol->ActiveFlag = true;
     1071  MolList->insert(mol);
    10711072
    10721073  // 4. dissect the molecule into connected subgraphs
    1073   MolList->DissectMoleculeIntoConnectedSubgraphs(mol,this);
    1074 
    1075   delete(mol);
     1074  // don't do this here ...
     1075  //MolList->DissectMoleculeIntoConnectedSubgraphs(mol,this);
     1076  //delete(mol);
     1077
    10761078  delete(FileBuffer);
    10771079};
  • src/molecule_graph.cpp

    rebbd3d r1cf5df  
    11171117  bool status = true;
    11181118  if (ReferenceStack->IsEmpty()) {
    1119     eLog() << Verbose(0) << "ReferenceStack is empty!" << endl;
    1120     performCriticalExit();
     1119    Log() << Verbose(1) << "ReferenceStack is empty!" << endl;
    11211120    return false;
    11221121  }
  • src/moleculelist.cpp

    rebbd3d r1cf5df  
    402402  input.open(line.c_str());
    403403  if (input == NULL) {
    404     eLog() << Verbose(0) << endl << "Unable to open " << line << ", is the directory correct?" << endl;
    405     performCriticalExit();
     404    Log() << Verbose(1) << endl << "Unable to open " << line << ", is the directory correct?" << endl;
    406405    return false;
    407406  }
  • src/parser.cpp

    rebbd3d r1cf5df  
    158158  //Log() << Verbose(0) << "Opening " << name << " ... "  << input << endl;
    159159  if (input == NULL) {
    160     eLog() << Verbose(0) << endl << "Unable to open " << name << ", is the directory correct?" << endl;
    161     performCriticalExit();
     160    eLog() << Verbose(1) << endl << "Unable to open " << name << ", is the directory correct?" << endl;
     161    //performCriticalExit();
    162162    return false;
    163163  }
  • src/tesselation.cpp

    rebbd3d r1cf5df  
    99
    1010#include "helpers.hpp"
     11#include "info.hpp"
    1112#include "linkedcell.hpp"
    1213#include "log.hpp"
     
    2223/** Constructor of BoundaryPointSet.
    2324 */
    24 BoundaryPointSet::BoundaryPointSet()
    25 {
    26   LinesCount = 0;
    27   Nr = -1;
    28   value = 0.;
     25BoundaryPointSet::BoundaryPointSet() :
     26    LinesCount(0),
     27    value(0.),
     28    Nr(-1)
     29{
     30        Info FunctionInfo(__func__);
     31        Log() << Verbose(1) << "Adding noname." << endl;
    2932};
    3033
     
    3235 * \param *Walker TesselPoint this boundary point represents
    3336 */
    34 BoundaryPointSet::BoundaryPointSet(TesselPoint * Walker)
    35 {
    36   node = Walker;
    37   LinesCount = 0;
    38   Nr = Walker->nr;
    39   value = 0.;
     37BoundaryPointSet::BoundaryPointSet(TesselPoint * Walker) :
     38  LinesCount(0),
     39  node(Walker),
     40  value(0.),
     41  Nr(Walker->nr)
     42{
     43        Info FunctionInfo(__func__);
     44  Log() << Verbose(1) << "Adding Node " << *Walker << endl;
    4045};
    4146
     
    4651BoundaryPointSet::~BoundaryPointSet()
    4752{
    48   //Log() << Verbose(5) << "Erasing point nr. " << Nr << "." << endl;
     53        Info FunctionInfo(__func__);
     54  //Log() << Verbose(0) << "Erasing point nr. " << Nr << "." << endl;
    4955  if (!lines.empty())
    5056    eLog() << Verbose(2) << "Memory Leak! I " << *this << " am still connected to some lines." << endl;
     
    5763void BoundaryPointSet::AddLine(class BoundaryLineSet *line)
    5864{
    59   Log() << Verbose(6) << "Adding " << *this << " to line " << *line << "."
     65        Info FunctionInfo(__func__);
     66  Log() << Verbose(1) << "Adding " << *this << " to line " << *line << "."
    6067      << endl;
    6168  if (line->endpoints[0] == this)
     
    8592/** Constructor of BoundaryLineSet.
    8693 */
    87 BoundaryLineSet::BoundaryLineSet()
    88 {
     94BoundaryLineSet::BoundaryLineSet() :
     95    Nr(-1)
     96{
     97        Info FunctionInfo(__func__);
    8998  for (int i = 0; i < 2; i++)
    9099    endpoints[i] = NULL;
    91   Nr = -1;
    92100};
    93101
     
    99107BoundaryLineSet::BoundaryLineSet(class BoundaryPointSet *Point[2], const int number)
    100108{
     109        Info FunctionInfo(__func__);
    101110  // set number
    102111  Nr = number;
     
    106115  Point[0]->AddLine(this); //Taken out, to check whether we can avoid unwanted double adding.
    107116  Point[1]->AddLine(this); //
     117  // set skipped to false
     118  skipped = false;
    108119  // clear triangles list
    109   Log() << Verbose(5) << "New Line with endpoints " << *this << "." << endl;
     120  Log() << Verbose(0) << "New Line with endpoints " << *this << "." << endl;
    110121};
    111122
     
    116127BoundaryLineSet::~BoundaryLineSet()
    117128{
     129        Info FunctionInfo(__func__);
    118130  int Numbers[2];
    119131
     
    134146        for (LineMap::iterator Runner = erasor.first; Runner != erasor.second; Runner++)
    135147          if ((*Runner).second == this) {
    136             //Log() << Verbose(5) << "Removing Line Nr. " << Nr << " in boundary point " << *endpoints[i] << "." << endl;
     148            //Log() << Verbose(0) << "Removing Line Nr. " << Nr << " in boundary point " << *endpoints[i] << "." << endl;
    137149            endpoints[i]->lines.erase(Runner);
    138150            break;
     
    140152      } else { // there's just a single line left
    141153        if (endpoints[i]->lines.erase(Nr)) {
    142           //Log() << Verbose(5) << "Removing Line Nr. " << Nr << " in boundary point " << *endpoints[i] << "." << endl;
     154          //Log() << Verbose(0) << "Removing Line Nr. " << Nr << " in boundary point " << *endpoints[i] << "." << endl;
    143155        }
    144156      }
    145157      if (endpoints[i]->lines.empty()) {
    146         //Log() << Verbose(5) << *endpoints[i] << " has no more lines it's attached to, erasing." << endl;
     158        //Log() << Verbose(0) << *endpoints[i] << " has no more lines it's attached to, erasing." << endl;
    147159        if (endpoints[i] != NULL) {
    148160          delete(endpoints[i]);
     
    161173void BoundaryLineSet::AddTriangle(class BoundaryTriangleSet *triangle)
    162174{
    163   Log() << Verbose(6) << "Add " << triangle->Nr << " to line " << *this << "." << endl;
     175        Info FunctionInfo(__func__);
     176  Log() << Verbose(0) << "Add " << triangle->Nr << " to line " << *this << "." << endl;
    164177  triangles.insert(TrianglePair(triangle->Nr, triangle));
    165178};
     
    171184bool BoundaryLineSet::IsConnectedTo(class BoundaryLineSet *line)
    172185{
     186        Info FunctionInfo(__func__);
    173187  if ((endpoints[0] == line->endpoints[0]) || (endpoints[1] == line->endpoints[0]) || (endpoints[0] == line->endpoints[1]) || (endpoints[1] == line->endpoints[1]))
    174188    return true;
     
    185199bool BoundaryLineSet::CheckConvexityCriterion()
    186200{
     201        Info FunctionInfo(__func__);
    187202  Vector BaseLineCenter, BaseLineNormal, BaseLine, helper[2], NormalCheck;
    188203  // get the two triangles
    189204  if (triangles.size() != 2) {
    190     eLog() << Verbose(1) << "Baseline " << *this << " is connected to less than two triangles, Tesselation incomplete!" << endl;
     205    eLog() << Verbose(0) << "Baseline " << *this << " is connected to less than two triangles, Tesselation incomplete!" << endl;
    191206    return true;
    192207  }
    193208  // check normal vectors
    194209  // have a normal vector on the base line pointing outwards
    195   //Log() << Verbose(3) << "INFO: " << *this << " has vectors at " << *(endpoints[0]->node->node) << " and at " << *(endpoints[1]->node->node) << "." << endl;
     210  //Log() << Verbose(0) << "INFO: " << *this << " has vectors at " << *(endpoints[0]->node->node) << " and at " << *(endpoints[1]->node->node) << "." << endl;
    196211  BaseLineCenter.CopyVector(endpoints[0]->node->node);
    197212  BaseLineCenter.AddVector(endpoints[1]->node->node);
     
    199214  BaseLine.CopyVector(endpoints[0]->node->node);
    200215  BaseLine.SubtractVector(endpoints[1]->node->node);
    201   //Log() << Verbose(3) << "INFO: Baseline is " << BaseLine << " and its center is at " << BaseLineCenter << "." << endl;
     216  //Log() << Verbose(0) << "INFO: Baseline is " << BaseLine << " and its center is at " << BaseLineCenter << "." << endl;
    202217
    203218  BaseLineNormal.Zero();
     
    207222  class BoundaryPointSet *node = NULL;
    208223  for(TriangleMap::iterator runner = triangles.begin(); runner != triangles.end(); runner++) {
    209     //Log() << Verbose(3) << "INFO: NormalVector of " << *(runner->second) << " is " << runner->second->NormalVector << "." << endl;
     224    //Log() << Verbose(0) << "INFO: NormalVector of " << *(runner->second) << " is " << runner->second->NormalVector << "." << endl;
    210225    NormalCheck.AddVector(&runner->second->NormalVector);
    211226    NormalCheck.Scale(sign);
     
    214229      BaseLineNormal.CopyVector(&runner->second->NormalVector);   // yes, copy second on top of first
    215230    else {
    216       Log() << Verbose(1) << "CRITICAL: Triangle " << *runner->second << " has zero normal vector!" << endl;
    217       exit(255);
     231      eLog() << Verbose(0) << "Triangle " << *runner->second << " has zero normal vector!" << endl;
    218232    }
    219233    node = runner->second->GetThirdEndpoint(this);
    220234    if (node != NULL) {
    221       //Log() << Verbose(3) << "INFO: Third node for triangle " << *(runner->second) << " is " << *node << " at " << *(node->node->node) << "." << endl;
     235      //Log() << Verbose(0) << "INFO: Third node for triangle " << *(runner->second) << " is " << *node << " at " << *(node->node->node) << "." << endl;
    222236      helper[i].CopyVector(node->node->node);
    223237      helper[i].SubtractVector(&BaseLineCenter);
    224238      helper[i].MakeNormalVector(&BaseLine);  // we want to compare the triangle's heights' angles!
    225       //Log() << Verbose(4) << "INFO: Height vector with respect to baseline is " << helper[i] << "." << endl;
     239      //Log() << Verbose(0) << "INFO: Height vector with respect to baseline is " << helper[i] << "." << endl;
    226240      i++;
    227241    } else {
    228       //eLog() << Verbose(1) << "I cannot find third node in triangle, something's wrong." << endl;
     242      eLog() << Verbose(1) << "I cannot find third node in triangle, something's wrong." << endl;
    229243      return true;
    230244    }
    231245  }
    232   //Log() << Verbose(3) << "INFO: BaselineNormal is " << BaseLineNormal << "." << endl;
     246  //Log() << Verbose(0) << "INFO: BaselineNormal is " << BaseLineNormal << "." << endl;
    233247  if (NormalCheck.NormSquared() < MYEPSILON) {
    234     Log() << Verbose(3) << "ACCEPT: Normalvectors of both triangles are the same: convex." << endl;
     248    Log() << Verbose(0) << "ACCEPT: Normalvectors of both triangles are the same: convex." << endl;
    235249    return true;
    236250  }
     
    238252  double angle = GetAngle(helper[0], helper[1], BaseLineNormal);
    239253  if ((angle - M_PI) > -MYEPSILON) {
    240     Log() << Verbose(3) << "ACCEPT: Angle is greater than pi: convex." << endl;
     254    Log() << Verbose(0) << "ACCEPT: Angle is greater than pi: convex." << endl;
    241255    return true;
    242256  } else {
    243     Log() << Verbose(3) << "REJECT: Angle is less than pi: concave." << endl;
     257    Log() << Verbose(0) << "REJECT: Angle is less than pi: concave." << endl;
    244258    return false;
    245259  }
     
    252266bool BoundaryLineSet::ContainsBoundaryPoint(class BoundaryPointSet *point)
    253267{
     268        Info FunctionInfo(__func__);
    254269  for(int i=0;i<2;i++)
    255270    if (point == endpoints[i])
     
    264279class BoundaryPointSet *BoundaryLineSet::GetOtherEndpoint(class BoundaryPointSet *point)
    265280{
     281        Info FunctionInfo(__func__);
    266282  if (endpoints[0] == point)
    267283    return endpoints[1];
     
    286302/** Constructor for BoundaryTriangleSet.
    287303 */
    288 BoundaryTriangleSet::BoundaryTriangleSet()
    289 {
     304BoundaryTriangleSet::BoundaryTriangleSet() :
     305  Nr(-1)
     306{
     307        Info FunctionInfo(__func__);
    290308  for (int i = 0; i < 3; i++)
    291309    {
     
    293311      lines[i] = NULL;
    294312    }
    295   Nr = -1;
    296313};
    297314
     
    300317 * \param number number of triangle
    301318 */
    302 BoundaryTriangleSet::BoundaryTriangleSet(class BoundaryLineSet *line[3], int number)
    303 {
     319BoundaryTriangleSet::BoundaryTriangleSet(class BoundaryLineSet *line[3], int number) :
     320  Nr(number)
     321{
     322        Info FunctionInfo(__func__);
    304323  // set number
    305   Nr = number;
    306324  // set lines
    307   Log() << Verbose(5) << "New triangle " << Nr << ":" << endl;
    308   for (int i = 0; i < 3; i++)
    309     {
    310       lines[i] = line[i];
    311       lines[i]->AddTriangle(this);
    312     }
     325  for (int i = 0; i < 3; i++) {
     326    lines[i] = line[i];
     327    lines[i]->AddTriangle(this);
     328  }
    313329  // get ascending order of endpoints
    314   map<int, class BoundaryPointSet *> OrderMap;
     330  PointMap OrderMap;
    315331  for (int i = 0; i < 3; i++)
    316332    // for all three lines
    317     for (int j = 0; j < 2; j++)
    318       { // for both endpoints
    319         OrderMap.insert(pair<int, class BoundaryPointSet *> (
    320             line[i]->endpoints[j]->Nr, line[i]->endpoints[j]));
    321         // and we don't care whether insertion fails
    322       }
     333    for (int j = 0; j < 2; j++) { // for both endpoints
     334      OrderMap.insert(pair<int, class BoundaryPointSet *> (
     335          line[i]->endpoints[j]->Nr, line[i]->endpoints[j]));
     336      // and we don't care whether insertion fails
     337    }
    323338  // set endpoints
    324339  int Counter = 0;
    325   Log() << Verbose(6) << " with end points ";
    326   for (map<int, class BoundaryPointSet *>::iterator runner = OrderMap.begin(); runner
    327       != OrderMap.end(); runner++)
    328     {
    329       endpoints[Counter] = runner->second;
    330       Log() << Verbose(0) << " " << *endpoints[Counter];
    331       Counter++;
    332     }
    333   if (Counter < 3)
    334     {
    335       eLog() << Verbose(0) << "ERROR! We have a triangle with only two distinct endpoints!" << endl;
    336       performCriticalExit();
    337     }
    338   Log() << Verbose(0) << "." << endl;
     340  Log() << Verbose(0) << "New triangle " << Nr << " with end points: " << endl;
     341  for (PointMap::iterator runner = OrderMap.begin(); runner != OrderMap.end(); runner++) {
     342    endpoints[Counter] = runner->second;
     343    Log() << Verbose(0) << " " << *endpoints[Counter] << endl;
     344    Counter++;
     345  }
     346  if (Counter < 3) {
     347    eLog() << Verbose(0) << "We have a triangle with only two distinct endpoints!" << endl;
     348    performCriticalExit();
     349  }
    339350};
    340351
     
    345356BoundaryTriangleSet::~BoundaryTriangleSet()
    346357{
     358        Info FunctionInfo(__func__);
    347359  for (int i = 0; i < 3; i++) {
    348360    if (lines[i] != NULL) {
    349361      if (lines[i]->triangles.erase(Nr)) {
    350         //Log() << Verbose(5) << "Triangle Nr." << Nr << " erased in line " << *lines[i] << "." << endl;
     362        //Log() << Verbose(0) << "Triangle Nr." << Nr << " erased in line " << *lines[i] << "." << endl;
    351363      }
    352364      if (lines[i]->triangles.empty()) {
    353           //Log() << Verbose(5) << *lines[i] << " is no more attached to any triangle, erasing." << endl;
     365          //Log() << Verbose(0) << *lines[i] << " is no more attached to any triangle, erasing." << endl;
    354366          delete (lines[i]);
    355367          lines[i] = NULL;
     
    357369    }
    358370  }
    359   //Log() << Verbose(5) << "Erasing triangle Nr." << Nr << " itself." << endl;
     371  //Log() << Verbose(0) << "Erasing triangle Nr." << Nr << " itself." << endl;
    360372};
    361373
     
    366378void BoundaryTriangleSet::GetNormalVector(Vector &OtherVector)
    367379{
     380        Info FunctionInfo(__func__);
    368381  // get normal vector
    369382  NormalVector.MakeNormalVector(endpoints[0]->node->node, endpoints[1]->node->node, endpoints[2]->node->node);
     
    372385  if (NormalVector.ScalarProduct(&OtherVector) > 0.)
    373386    NormalVector.Scale(-1.);
     387  Log() << Verbose(1) << "Normal Vector is " << NormalVector << "." << endl;
    374388};
    375389
     
    388402bool BoundaryTriangleSet::GetIntersectionInsideTriangle(Vector *MolCenter, Vector *x, Vector *Intersection)
    389403{
     404        Info FunctionInfo(__func__);
    390405  Vector CrossPoint;
    391406  Vector helper;
    392407
    393408  if (!Intersection->GetIntersectionWithPlane(&NormalVector, endpoints[0]->node->node, MolCenter, x)) {
    394     Log() << Verbose(1) << "Alas! Intersection with plane failed - at least numerically - the intersection is not on the plane!" << endl;
     409    eLog() << Verbose(1) << "Alas! Intersection with plane failed - at least numerically - the intersection is not on the plane!" << endl;
    395410    return false;
    396411  }
     
    408423  } while (CrossPoint.NormSquared() < MYEPSILON);
    409424  if (i==3) {
    410     eLog() << Verbose(1) << "Could not find any cross points, something's utterly wrong here!" << endl;
    411     exit(255);
     425    eLog() << Verbose(0) << "Could not find any cross points, something's utterly wrong here!" << endl;
    412426  }
    413427  CrossPoint.SubtractVector(endpoints[i%3]->node->node);  // cross point was returned as absolute vector
     
    428442bool BoundaryTriangleSet::ContainsBoundaryLine(class BoundaryLineSet *line)
    429443{
     444        Info FunctionInfo(__func__);
    430445  for(int i=0;i<3;i++)
    431446    if (line == lines[i])
     
    440455bool BoundaryTriangleSet::ContainsBoundaryPoint(class BoundaryPointSet *point)
    441456{
     457        Info FunctionInfo(__func__);
    442458  for(int i=0;i<3;i++)
    443459    if (point == endpoints[i])
     
    452468bool BoundaryTriangleSet::ContainsBoundaryPoint(class TesselPoint *point)
    453469{
     470        Info FunctionInfo(__func__);
    454471  for(int i=0;i<3;i++)
    455472    if (point == endpoints[i]->node)
     
    464481bool BoundaryTriangleSet::IsPresentTupel(class BoundaryPointSet *Points[3])
    465482{
     483        Info FunctionInfo(__func__);
    466484  return (((endpoints[0] == Points[0])
    467485            || (endpoints[0] == Points[1])
     
    485503bool BoundaryTriangleSet::IsPresentTupel(class BoundaryTriangleSet *T)
    486504{
     505        Info FunctionInfo(__func__);
    487506  return (((endpoints[0] == T->endpoints[0])
    488507            || (endpoints[0] == T->endpoints[1])
     
    506525class BoundaryPointSet *BoundaryTriangleSet::GetThirdEndpoint(class BoundaryLineSet *line)
    507526{
     527        Info FunctionInfo(__func__);
    508528  // sanity check
    509529  if (!ContainsBoundaryLine(line))
     
    522542void BoundaryTriangleSet::GetCenter(Vector *center)
    523543{
     544        Info FunctionInfo(__func__);
    524545  center->Zero();
    525546  for(int i=0;i<3;i++)
     
    534555ostream &operator <<(ostream &ost, const BoundaryTriangleSet &a)
    535556{
    536   ost << "[" << a.Nr << "|" << a.endpoints[0]->node->Name << " at " << *a.endpoints[0]->node->node << ","
    537       << a.endpoints[1]->node->Name << " at " << *a.endpoints[1]->node->node << "," << a.endpoints[2]->node->Name << " at " << *a.endpoints[2]->node->node << "]";
     557  ost << "[" << a.Nr << "|" << a.endpoints[0]->node->Name << "," << a.endpoints[1]->node->Name << "," << a.endpoints[2]->node->Name << "]";
     558//  ost << "[" << a.Nr << "|" << a.endpoints[0]->node->Name << " at " << *a.endpoints[0]->node->node << ","
     559//      << a.endpoints[1]->node->Name << " at " << *a.endpoints[1]->node->node << "," << a.endpoints[2]->node->Name << " at " << *a.endpoints[2]->node->node << "]";
    538560  return ost;
    539561};
    540562
     563// ======================================== Polygons on Boundary =================================
     564
     565/** Constructor for BoundaryPolygonSet.
     566 */
     567BoundaryPolygonSet::BoundaryPolygonSet() :
     568  Nr(-1)
     569{
     570  Info FunctionInfo(__func__);
     571};
     572
     573/** Destructor of BoundaryPolygonSet.
     574 * Just clears endpoints.
     575 * \note When removing triangles from a class Tesselation, use RemoveTesselationTriangle()
     576 */
     577BoundaryPolygonSet::~BoundaryPolygonSet()
     578{
     579  Info FunctionInfo(__func__);
     580  endpoints.clear();
     581  Log() << Verbose(1) << "Erasing polygon Nr." << Nr << " itself." << endl;
     582};
     583
     584/** Calculates the normal vector for this triangle.
     585 * Is made unique by comparison with \a OtherVector to point in the other direction.
     586 * \param &OtherVector direction vector to make normal vector unique.
     587 * \return allocated vector in normal direction
     588 */
     589Vector * BoundaryPolygonSet::GetNormalVector(const Vector &OtherVector) const
     590{
     591  Info FunctionInfo(__func__);
     592  // get normal vector
     593  Vector TemporaryNormal;
     594  Vector *TotalNormal = new Vector;
     595  PointSet::const_iterator Runner[3];
     596  for (int i=0;i<3; i++) {
     597    Runner[i] = endpoints.begin();
     598    for (int j = 0; j<i; j++) { // go as much further
     599      Runner[i]++;
     600      if (Runner[i] == endpoints.end()) {
     601        eLog() << Verbose(0) << "There are less than three endpoints in the polygon!" << endl;
     602        performCriticalExit();
     603      }
     604    }
     605  }
     606  TotalNormal->Zero();
     607  int counter=0;
     608  for (; Runner[2] != endpoints.end(); ) {
     609    TemporaryNormal.MakeNormalVector((*Runner[0])->node->node, (*Runner[1])->node->node, (*Runner[2])->node->node);
     610    for (int i=0;i<3;i++) // increase each of them
     611      Runner[i]++;
     612    TotalNormal->AddVector(&TemporaryNormal);
     613  }
     614  TotalNormal->Scale(1./(double)counter);
     615
     616  // make it always point inward (any offset vector onto plane projected onto normal vector suffices)
     617  if (TotalNormal->ScalarProduct(&OtherVector) > 0.)
     618    TotalNormal->Scale(-1.);
     619  Log() << Verbose(1) << "Normal Vector is " << *TotalNormal << "." << endl;
     620
     621  return TotalNormal;
     622};
     623
     624/** Calculates the center point of the triangle.
     625 * Is third of the sum of all endpoints.
     626 * \param *center central point on return.
     627 */
     628void BoundaryPolygonSet::GetCenter(Vector * const center) const
     629{
     630  Info FunctionInfo(__func__);
     631  center->Zero();
     632  int counter = 0;
     633  for(PointSet::const_iterator Runner = endpoints.begin(); Runner != endpoints.end(); Runner++) {
     634    center->AddVector((*Runner)->node->node);
     635    counter++;
     636  }
     637  center->Scale(1./(double)counter);
     638  Log() << Verbose(1) << "Center is at " << *center << "." << endl;
     639}
     640
     641/** Checks whether the polygons contains all three endpoints of the triangle.
     642 * \param *triangle triangle to test
     643 * \return true - triangle is contained polygon, false - is not
     644 */
     645bool BoundaryPolygonSet::ContainsBoundaryTriangle(const BoundaryTriangleSet * const triangle) const
     646{
     647  Info FunctionInfo(__func__);
     648  return ContainsPresentTupel(triangle->endpoints, 3);
     649};
     650
     651/** Checks whether the polygons contains both endpoints of the line.
     652 * \param *line line to test
     653 * \return true - line is of the triangle, false - is not
     654 */
     655bool BoundaryPolygonSet::ContainsBoundaryLine(const BoundaryLineSet * const line) const
     656{
     657  Info FunctionInfo(__func__);
     658  return ContainsPresentTupel(line->endpoints, 2);
     659};
     660
     661/** Checks whether point is any of the three endpoints this triangle contains.
     662 * \param *point point to test
     663 * \return true - point is of the triangle, false - is not
     664 */
     665bool BoundaryPolygonSet::ContainsBoundaryPoint(const BoundaryPointSet * const point) const
     666{
     667  Info FunctionInfo(__func__);
     668  for(PointSet::const_iterator Runner = endpoints.begin(); Runner != endpoints.end(); Runner++) {
     669    Log() << Verbose(0) << "Checking against " << **Runner << endl;
     670    if (point == (*Runner)) {
     671      Log() << Verbose(0) << " Contained." << endl;
     672      return true;
     673    }
     674  }
     675  Log() << Verbose(0) << " Not contained." << endl;
     676  return false;
     677};
     678
     679/** Checks whether point is any of the three endpoints this triangle contains.
     680 * \param *point TesselPoint to test
     681 * \return true - point is of the triangle, false - is not
     682 */
     683bool BoundaryPolygonSet::ContainsBoundaryPoint(const TesselPoint * const point) const
     684{
     685  Info FunctionInfo(__func__);
     686  for(PointSet::const_iterator Runner = endpoints.begin(); Runner != endpoints.end(); Runner++)
     687    if (point == (*Runner)->node) {
     688      Log() << Verbose(0) << " Contained." << endl;
     689      return true;
     690    }
     691  Log() << Verbose(0) << " Not contained." << endl;
     692  return false;
     693};
     694
     695/** Checks whether given array of \a *Points coincide with polygons's endpoints.
     696 * \param **Points pointer to an array of BoundaryPointSet
     697 * \param dim dimension of array
     698 * \return true - set of points is contained in polygon, false - is not
     699 */
     700bool BoundaryPolygonSet::ContainsPresentTupel(const BoundaryPointSet * const * Points, const int dim) const
     701{
     702  Info FunctionInfo(__func__);
     703  int counter = 0;
     704  Log() << Verbose(1) << "Polygon is " << *this << endl;
     705  for(int i=0;i<dim;i++) {
     706    Log() << Verbose(1) << " Testing endpoint " << *Points[i] << endl;
     707    if (ContainsBoundaryPoint(Points[i])) {
     708      counter++;
     709    }
     710  }
     711
     712  if (counter == dim)
     713    return true;
     714  else
     715    return false;
     716};
     717
     718/** Checks whether given PointList coincide with polygons's endpoints.
     719 * \param &endpoints PointList
     720 * \return true - set of points is contained in polygon, false - is not
     721 */
     722bool BoundaryPolygonSet::ContainsPresentTupel(const PointSet &endpoints) const
     723{
     724  Info FunctionInfo(__func__);
     725  size_t counter = 0;
     726  Log() << Verbose(1) << "Polygon is " << *this << endl;
     727  for(PointSet::const_iterator Runner = endpoints.begin(); Runner != endpoints.end(); Runner++) {
     728    Log() << Verbose(1) << " Testing endpoint " << **Runner << endl;
     729    if (ContainsBoundaryPoint(*Runner))
     730      counter++;
     731  }
     732
     733  if (counter == endpoints.size())
     734    return true;
     735  else
     736    return false;
     737};
     738
     739/** Checks whether given set of \a *Points coincide with polygons's endpoints.
     740 * \param *P pointer to BoundaryPolygonSet
     741 * \return true - is the very triangle, false - is not
     742 */
     743bool BoundaryPolygonSet::ContainsPresentTupel(const BoundaryPolygonSet * const P) const
     744{
     745  return ContainsPresentTupel((const PointSet)P->endpoints);
     746};
     747
     748/** Gathers all the endpoints' triangles in a unique set.
     749 * \return set of all triangles
     750 */
     751TriangleSet * BoundaryPolygonSet::GetAllContainedTrianglesFromEndpoints() const
     752{
     753  Info FunctionInfo(__func__);
     754  pair <TriangleSet::iterator, bool> Tester;
     755  TriangleSet *triangles = new TriangleSet;
     756
     757  for(PointSet::const_iterator Runner = endpoints.begin(); Runner != endpoints.end(); Runner++)
     758    for(LineMap::const_iterator Walker = (*Runner)->lines.begin(); Walker != (*Runner)->lines.end(); Walker++)
     759      for(TriangleMap::const_iterator Sprinter = (Walker->second)->triangles.begin(); Sprinter != (Walker->second)->triangles.end(); Sprinter++) {
     760        //Log() << Verbose(0) << " Testing triangle " << *(Sprinter->second) << endl;
     761        if (ContainsBoundaryTriangle(Sprinter->second)) {
     762          Tester = triangles->insert(Sprinter->second);
     763          if (Tester.second)
     764            Log() << Verbose(0) << "Adding triangle " << *(Sprinter->second) << endl;
     765        }
     766      }
     767
     768  Log() << Verbose(1) << "The Polygon of " << endpoints.size() << " endpoints has " << triangles->size() << " unique triangles in total." << endl;
     769  return triangles;
     770};
     771
     772/** Fills the endpoints of this polygon from the triangles attached to \a *line.
     773 * \param *line lines with triangles attached
     774 * \return true - polygon contains endpoints, false - line was NULL
     775 */
     776bool BoundaryPolygonSet::FillPolygonFromTrianglesOfLine(const BoundaryLineSet * const line)
     777{
     778  Info FunctionInfo(__func__);
     779  pair <PointSet::iterator, bool> Tester;
     780  if (line == NULL)
     781    return false;
     782  Log() << Verbose(1) << "Filling polygon from line " << *line << endl;
     783  for(TriangleMap::const_iterator Runner = line->triangles.begin(); Runner != line->triangles.end(); Runner++) {
     784    for (int i=0;i<3;i++) {
     785      Tester = endpoints.insert((Runner->second)->endpoints[i]);
     786      if (Tester.second)
     787        Log() << Verbose(1) << "  Inserting endpoint " << *((Runner->second)->endpoints[i]) << endl;
     788    }
     789  }
     790
     791  return true;
     792};
     793
     794/** output operator for BoundaryPolygonSet.
     795 * \param &ost output stream
     796 * \param &a boundary polygon
     797 */
     798ostream &operator <<(ostream &ost, const BoundaryPolygonSet &a)
     799{
     800  ost << "[" << a.Nr << "|";
     801  for(PointSet::const_iterator Runner = a.endpoints.begin(); Runner != a.endpoints.end();) {
     802   ost << (*Runner)->node->Name;
     803   Runner++;
     804   if (Runner != a.endpoints.end())
     805     ost << ",";
     806  }
     807  ost<< "]";
     808  return ost;
     809};
     810
    541811// =========================================================== class TESSELPOINT ===========================================
    542812
     
    545815TesselPoint::TesselPoint()
    546816{
     817  Info FunctionInfo(__func__);
    547818  node = NULL;
    548819  nr = -1;
     
    554825TesselPoint::~TesselPoint()
    555826{
     827  Info FunctionInfo(__func__);
    556828};
    557829
     
    568840ostream & TesselPoint::operator << (ostream &ost)
    569841{
    570   ost << "[" << (Name) << "|" << this << "]";
     842        Info FunctionInfo(__func__);
     843  ost << "[" << (nr) << "|" << this << "]";
    571844  return ost;
    572845};
     
    579852PointCloud::PointCloud()
    580853{
    581 
     854        Info FunctionInfo(__func__);
    582855};
    583856
     
    586859PointCloud::~PointCloud()
    587860{
    588 
     861        Info FunctionInfo(__func__);
    589862};
    590863
     
    593866/** Constructor of class CandidateForTesselation.
    594867 */
    595 CandidateForTesselation::CandidateForTesselation(TesselPoint *candidate, BoundaryLineSet* line, Vector OptCandidateCenter, Vector OtherOptCandidateCenter) {
    596   point = candidate;
    597   BaseLine = line;
     868CandidateForTesselation::CandidateForTesselation (BoundaryLineSet* line) :
     869  BaseLine(line),
     870  ShortestAngle(2.*M_PI),
     871  OtherShortestAngle(2.*M_PI)
     872{
     873        Info FunctionInfo(__func__);
     874};
     875
     876
     877/** Constructor of class CandidateForTesselation.
     878 */
     879CandidateForTesselation::CandidateForTesselation (TesselPoint *candidate, BoundaryLineSet* line, Vector OptCandidateCenter, Vector OtherOptCandidateCenter) :
     880    BaseLine(line),
     881    ShortestAngle(2.*M_PI),
     882    OtherShortestAngle(2.*M_PI)
     883{
     884        Info FunctionInfo(__func__);
    598885  OptCenter.CopyVector(&OptCandidateCenter);
    599886  OtherOptCenter.CopyVector(&OtherOptCandidateCenter);
     
    603890 */
    604891CandidateForTesselation::~CandidateForTesselation() {
    605   point = NULL;
    606892  BaseLine = NULL;
    607893};
    608894
     895/** output operator for CandidateForTesselation.
     896 * \param &ost output stream
     897 * \param &a boundary line
     898 */
     899ostream & operator <<(ostream &ost, const  CandidateForTesselation &a)
     900{
     901  ost << "[" << a.BaseLine->Nr << "|" << a.BaseLine->endpoints[0]->node->Name << "," << a.BaseLine->endpoints[1]->node->Name << "] with ";
     902  if (a.pointlist.empty())
     903    ost << "no candidate.";
     904  else {
     905    ost << "candidate";
     906    if (a.pointlist.size() != 1)
     907      ost << "s ";
     908    else
     909      ost << " ";
     910    for (TesselPointList::const_iterator Runner = a.pointlist.begin(); Runner != a.pointlist.end(); Runner++)
     911      ost << *(*Runner) << " ";
     912    ost << " at angle " << (a.ShortestAngle)<< ".";
     913  }
     914
     915  return ost;
     916};
     917
     918
    609919// =========================================================== class TESSELATION ===========================================
    610920
    611921/** Constructor of class Tesselation.
    612922 */
    613 Tesselation::Tesselation()
    614 {
    615   PointsOnBoundaryCount = 0;
    616   LinesOnBoundaryCount = 0;
    617   TrianglesOnBoundaryCount = 0;
    618   InternalPointer = PointsOnBoundary.begin();
    619   LastTriangle = NULL;
    620   TriangleFilesWritten = 0;
     923Tesselation::Tesselation() :
     924  PointsOnBoundaryCount(0),
     925  LinesOnBoundaryCount(0),
     926  TrianglesOnBoundaryCount(0),
     927  LastTriangle(NULL),
     928  TriangleFilesWritten(0),
     929  InternalPointer(PointsOnBoundary.begin())
     930{
     931        Info FunctionInfo(__func__);
    621932}
    622933;
     
    627938Tesselation::~Tesselation()
    628939{
    629   Log() << Verbose(1) << "Free'ing TesselStruct ... " << endl;
     940        Info FunctionInfo(__func__);
     941  Log() << Verbose(0) << "Free'ing TesselStruct ... " << endl;
    630942  for (TriangleMap::iterator runner = TrianglesOnBoundary.begin(); runner != TrianglesOnBoundary.end(); runner++) {
    631943    if (runner->second != NULL) {
     
    635947      eLog() << Verbose(1) << "The triangle " << runner->first << " has already been free'd." << endl;
    636948  }
    637   Log() << Verbose(1) << "This envelope was written to file " << TriangleFilesWritten << " times(s)." << endl;
     949  Log() << Verbose(0) << "This envelope was written to file " << TriangleFilesWritten << " times(s)." << endl;
    638950}
    639951;
     
    644956Vector * Tesselation::GetCenter(ofstream *out) const
    645957{
     958        Info FunctionInfo(__func__);
    646959  Vector *Center = new Vector(0.,0.,0.);
    647960  int num=0;
     
    659972TesselPoint * Tesselation::GetPoint() const
    660973{
     974        Info FunctionInfo(__func__);
    661975  return (InternalPointer->second->node);
    662976};
     
    667981TesselPoint * Tesselation::GetTerminalPoint() const
    668982{
     983        Info FunctionInfo(__func__);
    669984  PointMap::const_iterator Runner = PointsOnBoundary.end();
    670985  Runner--;
     
    677992void Tesselation::GoToNext() const
    678993{
     994        Info FunctionInfo(__func__);
    679995  if (InternalPointer != PointsOnBoundary.end())
    680996    InternalPointer++;
     
    6861002void Tesselation::GoToPrevious() const
    6871003{
     1004        Info FunctionInfo(__func__);
    6881005  if (InternalPointer != PointsOnBoundary.begin())
    6891006    InternalPointer--;
     
    6951012void Tesselation::GoToFirst() const
    6961013{
     1014        Info FunctionInfo(__func__);
    6971015  InternalPointer = PointsOnBoundary.begin();
    6981016};
     
    7031021void Tesselation::GoToLast() const
    7041022{
     1023        Info FunctionInfo(__func__);
    7051024  InternalPointer = PointsOnBoundary.end();
    7061025  InternalPointer--;
     
    7121031bool Tesselation::IsEmpty() const
    7131032{
     1033        Info FunctionInfo(__func__);
    7141034  return (PointsOnBoundary.empty());
    7151035};
     
    7201040bool Tesselation::IsEnd() const
    7211041{
     1042        Info FunctionInfo(__func__);
    7221043  return (InternalPointer == PointsOnBoundary.end());
    7231044};
     
    7321053Tesselation::GuessStartingTriangle()
    7331054{
     1055        Info FunctionInfo(__func__);
    7341056  // 4b. create a starting triangle
    7351057  // 4b1. create all distances
     
    7781100          baseline->second.first->second->node->node,
    7791101          baseline->second.second->second->node->node);
    780       Log() << Verbose(2) << "Plane vector of candidate triangle is ";
    781       PlaneVector.Output();
    782       Log() << Verbose(0) << endl;
     1102      Log() << Verbose(2) << "Plane vector of candidate triangle is " << PlaneVector << endl;
    7831103      // 4. loop over all points
    7841104      double sign = 0.;
     
    7961116          if (fabs(distance) < 1e-4) // we need to have a small epsilon around 0 which is still ok
    7971117            continue;
    798           Log() << Verbose(3) << "Projection of " << checker->second->node->Name
    799               << " yields distance of " << distance << "." << endl;
     1118          Log() << Verbose(2) << "Projection of " << checker->second->node->Name << " yields distance of " << distance << "." << endl;
    8001119          tmp = distance / fabs(distance);
    8011120          // 4b. Any have different sign to than before? (i.e. would lie outside convex hull with this starting triangle)
     
    8501169      if (checker == PointsOnBoundary.end())
    8511170        {
    852           Log() << Verbose(0) << "Looks like we have a candidate!" << endl;
     1171          Log() << Verbose(2) << "Looks like we have a candidate!" << endl;
    8531172          break;
    8541173        }
     
    8801199  else
    8811200    {
    882       Log() << Verbose(1) << "No starting triangle found." << endl;
    883       exit(255);
     1201      eLog() << Verbose(0) << "No starting triangle found." << endl;
    8841202    }
    8851203}
     
    9011219void Tesselation::TesselateOnBoundary(const PointCloud * const cloud)
    9021220{
     1221        Info FunctionInfo(__func__);
    9031222  bool flag;
    9041223  PointMap::iterator winner;
     
    9191238        // get peak point with respect to this base line's only triangle
    9201239        BTS = baseline->second->triangles.begin()->second; // there is only one triangle so far
    921         Log() << Verbose(2) << "Current baseline is between " << *(baseline->second) << "." << endl;
     1240        Log() << Verbose(0) << "Current baseline is between " << *(baseline->second) << "." << endl;
    9221241        for (int i = 0; i < 3; i++)
    9231242          if ((BTS->endpoints[i] != baseline->second->endpoints[0]) && (BTS->endpoints[i] != baseline->second->endpoints[1]))
    9241243            peak = BTS->endpoints[i];
    925         Log() << Verbose(3) << " and has peak " << *peak << "." << endl;
     1244        Log() << Verbose(1) << " and has peak " << *peak << "." << endl;
    9261245
    9271246        // prepare some auxiliary vectors
     
    9381257          CenterVector.AddVector(BTS->endpoints[i]->node->node);
    9391258        CenterVector.Scale(1. / 3.);
    940         Log() << Verbose(4) << "CenterVector of base triangle is " << CenterVector << endl;
     1259        Log() << Verbose(2) << "CenterVector of base triangle is " << CenterVector << endl;
    9411260
    9421261        // normal vector of triangle
     
    9451264        BTS->GetNormalVector(NormalVector);
    9461265        NormalVector.CopyVector(&BTS->NormalVector);
    947         Log() << Verbose(4) << "NormalVector of base triangle is " << NormalVector << endl;
     1266        Log() << Verbose(2) << "NormalVector of base triangle is " << NormalVector << endl;
    9481267
    9491268        // vector in propagation direction (out of triangle)
     
    9521271        TempVector.CopyVector(&CenterVector);
    9531272        TempVector.SubtractVector(baseline->second->endpoints[0]->node->node); // TempVector is vector on triangle plane pointing from one baseline egde towards center!
    954         //Log() << Verbose(2) << "Projection of propagation onto temp: " << PropagationVector.Projection(&TempVector) << "." << endl;
     1273        //Log() << Verbose(0) << "Projection of propagation onto temp: " << PropagationVector.Projection(&TempVector) << "." << endl;
    9551274        if (PropagationVector.ScalarProduct(&TempVector) > 0) // make sure normal propagation vector points outward from baseline
    9561275          PropagationVector.Scale(-1.);
    957         Log() << Verbose(4) << "PropagationVector of base triangle is " << PropagationVector << endl;
     1276        Log() << Verbose(2) << "PropagationVector of base triangle is " << PropagationVector << endl;
    9581277        winner = PointsOnBoundary.end();
    9591278
     
    9611280        for (PointMap::iterator target = PointsOnBoundary.begin(); target != PointsOnBoundary.end(); target++) {
    9621281          if ((target->second != baseline->second->endpoints[0]) && (target->second != baseline->second->endpoints[1])) { // don't take the same endpoints
    963             Log() << Verbose(3) << "Target point is " << *(target->second) << ":" << endl;
     1282            Log() << Verbose(1) << "Target point is " << *(target->second) << ":" << endl;
    9641283
    9651284            // first check direction, so that triangles don't intersect
     
    9681287            VirtualNormalVector.ProjectOntoPlane(&NormalVector);
    9691288            TempAngle = VirtualNormalVector.Angle(&PropagationVector);
    970             Log() << Verbose(4) << "VirtualNormalVector is " << VirtualNormalVector << " and PropagationVector is " << PropagationVector << "." << endl;
     1289            Log() << Verbose(2) << "VirtualNormalVector is " << VirtualNormalVector << " and PropagationVector is " << PropagationVector << "." << endl;
    9711290            if (TempAngle > (M_PI/2.)) { // no bends bigger than Pi/2 (90 degrees)
    972               Log() << Verbose(4) << "Angle on triangle plane between propagation direction and base line to " << *(target->second) << " is " << TempAngle << ", bad direction!" << endl;
     1291              Log() << Verbose(2) << "Angle on triangle plane between propagation direction and base line to " << *(target->second) << " is " << TempAngle << ", bad direction!" << endl;
    9731292              continue;
    9741293            } else
    975               Log() << Verbose(4) << "Angle on triangle plane between propagation direction and base line to " << *(target->second) << " is " << TempAngle << ", good direction!" << endl;
     1294              Log() << Verbose(2) << "Angle on triangle plane between propagation direction and base line to " << *(target->second) << " is " << TempAngle << ", good direction!" << endl;
    9761295
    9771296            // check first and second endpoint (if any connecting line goes to target has at least not more than 1 triangle)
     
    9791298            LineChecker[1] = baseline->second->endpoints[1]->lines.find(target->first);
    9801299            if (((LineChecker[0] != baseline->second->endpoints[0]->lines.end()) && (LineChecker[0]->second->triangles.size() == 2))) {
    981               Log() << Verbose(4) << *(baseline->second->endpoints[0]) << " has line " << *(LineChecker[0]->second) << " to " << *(target->second) << " as endpoint with " << LineChecker[0]->second->triangles.size() << " triangles." << endl;
     1300              Log() << Verbose(2) << *(baseline->second->endpoints[0]) << " has line " << *(LineChecker[0]->second) << " to " << *(target->second) << " as endpoint with " << LineChecker[0]->second->triangles.size() << " triangles." << endl;
    9821301              continue;
    9831302            }
    9841303            if (((LineChecker[1] != baseline->second->endpoints[1]->lines.end()) && (LineChecker[1]->second->triangles.size() == 2))) {
    985               Log() << Verbose(4) << *(baseline->second->endpoints[1]) << " has line " << *(LineChecker[1]->second) << " to " << *(target->second) << " as endpoint with " << LineChecker[1]->second->triangles.size() << " triangles." << endl;
     1304              Log() << Verbose(2) << *(baseline->second->endpoints[1]) << " has line " << *(LineChecker[1]->second) << " to " << *(target->second) << " as endpoint with " << LineChecker[1]->second->triangles.size() << " triangles." << endl;
    9861305              continue;
    9871306            }
     
    10001319            helper.ProjectOntoPlane(&TempVector);
    10011320            if (fabs(helper.NormSquared()) < MYEPSILON) {
    1002               Log() << Verbose(4) << "Chosen set of vectors is linear dependent." << endl;
     1321              Log() << Verbose(2) << "Chosen set of vectors is linear dependent." << endl;
    10031322              continue;
    10041323            }
     
    10171336            // calculate angle
    10181337            TempAngle = NormalVector.Angle(&VirtualNormalVector);
    1019             Log() << Verbose(4) << "NormalVector is " << VirtualNormalVector << " and the angle is " << TempAngle << "." << endl;
     1338            Log() << Verbose(2) << "NormalVector is " << VirtualNormalVector << " and the angle is " << TempAngle << "." << endl;
    10201339            if ((SmallestAngle - TempAngle) > MYEPSILON) { // set to new possible winner
    10211340              SmallestAngle = TempAngle;
    10221341              winner = target;
    1023               Log() << Verbose(4) << "New winner " << *winner->second->node << " due to smaller angle between normal vectors." << endl;
     1342              Log() << Verbose(2) << "New winner " << *winner->second->node << " due to smaller angle between normal vectors." << endl;
    10241343            } else if (fabs(SmallestAngle - TempAngle) < MYEPSILON) { // check the angle to propagation, both possible targets are in one plane! (their normals have same angle)
    10251344              // hence, check the angles to some normal direction from our base line but in this common plane of both targets...
     
    10391358                SmallestAngle = TempAngle;
    10401359                winner = target;
    1041                 Log() << Verbose(4) << "New winner " << *winner->second->node << " due to smaller angle " << TempAngle << " to propagation direction." << endl;
     1360                Log() << Verbose(2) << "New winner " << *winner->second->node << " due to smaller angle " << TempAngle << " to propagation direction." << endl;
    10421361              } else
    1043                 Log() << Verbose(4) << "Keeping old winner " << *winner->second->node << " due to smaller angle to propagation direction." << endl;
     1362                Log() << Verbose(2) << "Keeping old winner " << *winner->second->node << " due to smaller angle to propagation direction." << endl;
    10441363            } else
    1045               Log() << Verbose(4) << "Keeping old winner " << *winner->second->node << " due to smaller angle between normal vectors." << endl;
     1364              Log() << Verbose(2) << "Keeping old winner " << *winner->second->node << " due to smaller angle between normal vectors." << endl;
    10461365          }
    10471366        } // end of loop over all boundary points
     
    10491368        // 5b. The point of the above whose triangle has the greatest angle with the triangle the current line belongs to (it only belongs to one, remember!): New triangle
    10501369        if (winner != PointsOnBoundary.end()) {
    1051           Log() << Verbose(2) << "Winning target point is " << *(winner->second) << " with angle " << SmallestAngle << "." << endl;
     1370          Log() << Verbose(0) << "Winning target point is " << *(winner->second) << " with angle " << SmallestAngle << "." << endl;
    10521371          // create the lins of not yet present
    10531372          BLS[0] = baseline->second;
     
    10791398          TrianglesOnBoundaryCount++;
    10801399        } else {
    1081           Log() << Verbose(1) << "I could not determine a winner for this baseline " << *(baseline->second) << "." << endl;
     1400          eLog() << Verbose(2) << "I could not determine a winner for this baseline " << *(baseline->second) << "." << endl;
    10821401        }
    10831402
    10841403        // 5d. If the set of lines is not yet empty, go to 5. and continue
    10851404      } else
    1086         Log() << Verbose(2) << "Baseline candidate " << *(baseline->second) << " has a triangle count of " << baseline->second->triangles.size() << "." << endl;
     1405        Log() << Verbose(0) << "Baseline candidate " << *(baseline->second) << " has a triangle count of " << baseline->second->triangles.size() << "." << endl;
    10871406  } while (flag);
    10881407
     
    10991418bool Tesselation::InsertStraddlingPoints(const PointCloud *cloud, const LinkedCell *LC)
    11001419{
     1420        Info FunctionInfo(__func__);
    11011421  Vector Intersection, Normal;
    11021422  TesselPoint *Walker = NULL;
     
    11051425  bool AddFlag = false;
    11061426  LinkedCell *BoundaryPoints = NULL;
    1107 
    1108   Log() << Verbose(1) << "Begin of InsertStraddlingPoints" << endl;
    11091427
    11101428  cloud->GoToFirst();
     
    11171435    }
    11181436    Walker = cloud->GetPoint();
    1119     Log() << Verbose(2) << "Current point is " << *Walker << "." << endl;
     1437    Log() << Verbose(0) << "Current point is " << *Walker << "." << endl;
    11201438    // get the next triangle
    11211439    triangles = FindClosestTrianglesToPoint(Walker->node, BoundaryPoints);
    11221440    BTS = triangles->front();
    11231441    if ((triangles == NULL) || (BTS->ContainsBoundaryPoint(Walker))) {
    1124       Log() << Verbose(2) << "No triangles found, probably a tesselation point itself." << endl;
     1442      Log() << Verbose(0) << "No triangles found, probably a tesselation point itself." << endl;
    11251443      cloud->GoToNext();
    11261444      continue;
    11271445    } else {
    11281446    }
    1129     Log() << Verbose(2) << "Closest triangle is " << *BTS << "." << endl;
     1447    Log() << Verbose(0) << "Closest triangle is " << *BTS << "." << endl;
    11301448    // get the intersection point
    11311449    if (BTS->GetIntersectionInsideTriangle(Center, Walker->node, &Intersection)) {
    1132       Log() << Verbose(2) << "We have an intersection at " << Intersection << "." << endl;
     1450      Log() << Verbose(0) << "We have an intersection at " << Intersection << "." << endl;
    11331451      // we have the intersection, check whether in- or outside of boundary
    11341452      if ((Center->DistanceSquared(Walker->node) - Center->DistanceSquared(&Intersection)) < -MYEPSILON) {
    11351453        // inside, next!
    1136         Log() << Verbose(2) << *Walker << " is inside wrt triangle " << *BTS << "." << endl;
     1454        Log() << Verbose(0) << *Walker << " is inside wrt triangle " << *BTS << "." << endl;
    11371455      } else {
    11381456        // outside!
    1139         Log() << Verbose(2) << *Walker << " is outside wrt triangle " << *BTS << "." << endl;
     1457        Log() << Verbose(0) << *Walker << " is outside wrt triangle " << *BTS << "." << endl;
    11401458        class BoundaryLineSet *OldLines[3], *NewLines[3];
    11411459        class BoundaryPointSet *OldPoints[3], *NewPoint;
     
    11471465        Normal.CopyVector(&BTS->NormalVector);
    11481466        // add Walker to boundary points
    1149         Log() << Verbose(2) << "Adding " << *Walker << " to BoundaryPoints." << endl;
     1467        Log() << Verbose(0) << "Adding " << *Walker << " to BoundaryPoints." << endl;
    11501468        AddFlag = true;
    11511469        if (AddBoundaryPoint(Walker,0))
     
    11541472          continue;
    11551473        // remove triangle
    1156         Log() << Verbose(2) << "Erasing triangle " << *BTS << "." << endl;
     1474        Log() << Verbose(0) << "Erasing triangle " << *BTS << "." << endl;
    11571475        TrianglesOnBoundary.erase(BTS->Nr);
    11581476        delete(BTS);
     
    11621480          BPS[1] = OldPoints[i];
    11631481          NewLines[i] = new class BoundaryLineSet(BPS, LinesOnBoundaryCount);
    1164           Log() << Verbose(3) << "Creating new line " << *NewLines[i] << "." << endl;
     1482          Log() << Verbose(1) << "Creating new line " << *NewLines[i] << "." << endl;
    11651483          LinesOnBoundary.insert(LinePair(LinesOnBoundaryCount, NewLines[i])); // no need for check for unique insertion as BPS[0] is definitely a new one
    11661484          LinesOnBoundaryCount++;
     
    11731491            if (NewLines[j]->IsConnectedTo(BLS[0])) {
    11741492              if (n>2) {
    1175                 Log() << Verbose(1) << BLS[0] << " connects to all of the new lines?!" << endl;
     1493                eLog() << Verbose(2) << BLS[0] << " connects to all of the new lines?!" << endl;
    11761494                return false;
    11771495              } else
     
    11841502          BTS->GetNormalVector(Normal);
    11851503          Normal.Scale(-1.);
    1186           Log() << Verbose(2) << "Created new triangle " << *BTS << "." << endl;
     1504          Log() << Verbose(0) << "Created new triangle " << *BTS << "." << endl;
    11871505          TrianglesOnBoundary.insert(TrianglePair(TrianglesOnBoundaryCount, BTS));
    11881506          TrianglesOnBoundaryCount++;
     
    11981516  // exit
    11991517  delete(Center);
    1200   Log() << Verbose(1) << "End of InsertStraddlingPoints" << endl;
    12011518  return true;
    12021519};
     
    12091526bool Tesselation::AddBoundaryPoint(TesselPoint * Walker, const int n)
    12101527{
     1528        Info FunctionInfo(__func__);
    12111529  PointTestPair InsertUnique;
    12121530  BPS[n] = new class BoundaryPointSet(Walker);
     
    12301548void Tesselation::AddTesselationPoint(TesselPoint* Candidate, const int n)
    12311549{
     1550        Info FunctionInfo(__func__);
    12321551  PointTestPair InsertUnique;
    12331552  TPS[n] = new class BoundaryPointSet(Candidate);
     
    12371556  } else {
    12381557    delete TPS[n];
    1239     Log() << Verbose(4) << "Node " << *((InsertUnique.first)->second->node) << " is already present in PointsOnBoundary." << endl;
     1558    Log() << Verbose(0) << "Node " << *((InsertUnique.first)->second->node) << " is already present in PointsOnBoundary." << endl;
    12401559    TPS[n] = (InsertUnique.first)->second;
    12411560  }
     
    12501569void Tesselation::SetTesselationPoint(TesselPoint* Candidate, const int n) const
    12511570{
     1571        Info FunctionInfo(__func__);
    12521572  PointMap::const_iterator FindPoint = PointsOnBoundary.find(Candidate->nr);
    12531573  if (FindPoint != PointsOnBoundary.end())
     
    12671587  bool insertNewLine = true;
    12681588
    1269   if (a->lines.find(b->node->nr) != a->lines.end()) {
    1270     LineMap::iterator FindLine = a->lines.find(b->node->nr);
     1589  LineMap::iterator FindLine = a->lines.find(b->node->nr);
     1590  if (FindLine != a->lines.end()) {
     1591    Log() << Verbose(1) << "INFO: There is at least one line between " << *a << " and " << *b << ": " << *(FindLine->second) << "." << endl;
     1592
    12711593    pair<LineMap::iterator,LineMap::iterator> FindPair;
    12721594    FindPair = a->lines.equal_range(b->node->nr);
    1273     Log() << Verbose(5) << "INFO: There is at least one line between " << *a << " and " << *b << ": " << *(FindLine->second) << "." << endl;
    12741595
    12751596    for (FindLine = FindPair.first; FindLine != FindPair.second; FindLine++) {
     
    12771598      if (FindLine->second->triangles.size() < 2) {
    12781599        insertNewLine = false;
    1279         Log() << Verbose(4) << "Using existing line " << *FindLine->second << endl;
     1600        Log() << Verbose(0) << "Using existing line " << *FindLine->second << endl;
    12801601
    12811602        BPS[0] = FindLine->second->endpoints[0];
    12821603        BPS[1] = FindLine->second->endpoints[1];
    12831604        BLS[n] = FindLine->second;
     1605
     1606        // remove existing line from OpenLines
     1607        CandidateMap::iterator CandidateLine = OpenLines.find(BLS[n]);
     1608        if (CandidateLine != OpenLines.end()) {
     1609          Log() << Verbose(1) << " Removing line from OpenLines." << endl;
     1610          delete(CandidateLine->second);
     1611          OpenLines.erase(CandidateLine);
     1612        } else {
     1613          eLog() << Verbose(1) << "Line exists and is attached to less than two triangles, but not in OpenLines!" << endl;
     1614        }
    12841615
    12851616        break;
     
    13041635void Tesselation::AlwaysAddTesselationTriangleLine(class BoundaryPointSet *a, class BoundaryPointSet *b, const int n)
    13051636{
    1306   Log() << Verbose(4) << "Adding line [" << LinesOnBoundaryCount << "|" << *(a->node) << " and " << *(b->node) << "." << endl;
     1637        Info FunctionInfo(__func__);
     1638  Log() << Verbose(0) << "Adding open line [" << LinesOnBoundaryCount << "|" << *(a->node) << " and " << *(b->node) << "." << endl;
    13071639  BPS[0] = a;
    13081640  BPS[1] = b;
     
    13121644  // increase counter
    13131645  LinesOnBoundaryCount++;
     1646  // also add to open lines
     1647  CandidateForTesselation *CFT = new CandidateForTesselation(BLS[n]);
     1648  OpenLines.insert(pair< BoundaryLineSet *, CandidateForTesselation *> (BLS[n], CFT));
    13141649};
    13151650
     
    13191654void Tesselation::AddTesselationTriangle()
    13201655{
     1656        Info FunctionInfo(__func__);
    13211657  Log() << Verbose(1) << "Adding triangle to global TrianglesOnBoundary map." << endl;
    13221658
     
    13371673void Tesselation::AddTesselationTriangle(const int nr)
    13381674{
    1339   Log() << Verbose(1) << "Adding triangle to global TrianglesOnBoundary map." << endl;
     1675        Info FunctionInfo(__func__);
     1676  Log() << Verbose(0) << "Adding triangle to global TrianglesOnBoundary map." << endl;
    13401677
    13411678  // add triangle to global map
     
    13551692void Tesselation::RemoveTesselationTriangle(class BoundaryTriangleSet *triangle)
    13561693{
     1694        Info FunctionInfo(__func__);
    13571695  if (triangle == NULL)
    13581696    return;
    13591697  for (int i = 0; i < 3; i++) {
    13601698    if (triangle->lines[i] != NULL) {
    1361       Log() << Verbose(5) << "Removing triangle Nr." << triangle->Nr << " in line " << *triangle->lines[i] << "." << endl;
     1699      Log() << Verbose(0) << "Removing triangle Nr." << triangle->Nr << " in line " << *triangle->lines[i] << "." << endl;
    13621700      triangle->lines[i]->triangles.erase(triangle->Nr);
    13631701      if (triangle->lines[i]->triangles.empty()) {
    1364           Log() << Verbose(5) << *triangle->lines[i] << " is no more attached to any triangle, erasing." << endl;
     1702          Log() << Verbose(0) << *triangle->lines[i] << " is no more attached to any triangle, erasing." << endl;
    13651703          RemoveTesselationLine(triangle->lines[i]);
    13661704      } else {
    1367         Log() << Verbose(5) << *triangle->lines[i] << " is still attached to another triangle: ";
     1705        Log() << Verbose(0) << *triangle->lines[i] << " is still attached to another triangle: ";
     1706        OpenLines.insert(pair< BoundaryLineSet *, CandidateForTesselation *> (triangle->lines[i], NULL));
    13681707        for(TriangleMap::iterator TriangleRunner = triangle->lines[i]->triangles.begin(); TriangleRunner != triangle->lines[i]->triangles.end(); TriangleRunner++)
    13691708          Log() << Verbose(0) << "[" << (TriangleRunner->second)->Nr << "|" << *((TriangleRunner->second)->endpoints[0]) << ", " << *((TriangleRunner->second)->endpoints[1]) << ", " << *((TriangleRunner->second)->endpoints[2]) << "] \t";
    13701709        Log() << Verbose(0) << endl;
    13711710//        for (int j=0;j<2;j++) {
    1372 //          Log() << Verbose(5) << "Lines of endpoint " << *(triangle->lines[i]->endpoints[j]) << ": ";
     1711//          Log() << Verbose(0) << "Lines of endpoint " << *(triangle->lines[i]->endpoints[j]) << ": ";
    13731712//          for(LineMap::iterator LineRunner = triangle->lines[i]->endpoints[j]->lines.begin(); LineRunner != triangle->lines[i]->endpoints[j]->lines.end(); LineRunner++)
    13741713//            Log() << Verbose(0) << "[" << *(LineRunner->second) << "] \t";
     
    13821721
    13831722  if (TrianglesOnBoundary.erase(triangle->Nr))
    1384     Log() << Verbose(5) << "Removing triangle Nr. " << triangle->Nr << "." << endl;
     1723    Log() << Verbose(0) << "Removing triangle Nr. " << triangle->Nr << "." << endl;
    13851724  delete(triangle);
    13861725};
     
    13921731void Tesselation::RemoveTesselationLine(class BoundaryLineSet *line)
    13931732{
     1733        Info FunctionInfo(__func__);
    13941734  int Numbers[2];
    13951735
     
    14121752        for (LineMap::iterator Runner = erasor.first; Runner != erasor.second; Runner++)
    14131753          if ((*Runner).second == line) {
    1414             Log() << Verbose(5) << "Removing Line Nr. " << line->Nr << " in boundary point " << *line->endpoints[i] << "." << endl;
     1754            Log() << Verbose(0) << "Removing Line Nr. " << line->Nr << " in boundary point " << *line->endpoints[i] << "." << endl;
    14151755            line->endpoints[i]->lines.erase(Runner);
    14161756            break;
     
    14181758      } else { // there's just a single line left
    14191759        if (line->endpoints[i]->lines.erase(line->Nr))
    1420           Log() << Verbose(5) << "Removing Line Nr. " << line->Nr << " in boundary point " << *line->endpoints[i] << "." << endl;
     1760          Log() << Verbose(0) << "Removing Line Nr. " << line->Nr << " in boundary point " << *line->endpoints[i] << "." << endl;
    14211761      }
    14221762      if (line->endpoints[i]->lines.empty()) {
    1423         Log() << Verbose(5) << *line->endpoints[i] << " has no more lines it's attached to, erasing." << endl;
     1763        Log() << Verbose(0) << *line->endpoints[i] << " has no more lines it's attached to, erasing." << endl;
    14241764        RemoveTesselationPoint(line->endpoints[i]);
    14251765      } else {
    1426         Log() << Verbose(5) << *line->endpoints[i] << " has still lines it's attached to: ";
     1766        Log() << Verbose(0) << *line->endpoints[i] << " has still lines it's attached to: ";
    14271767        for(LineMap::iterator LineRunner = line->endpoints[i]->lines.begin(); LineRunner != line->endpoints[i]->lines.end(); LineRunner++)
    14281768          Log() << Verbose(0) << "[" << *(LineRunner->second) << "] \t";
     
    14371777
    14381778  if (LinesOnBoundary.erase(line->Nr))
    1439     Log() << Verbose(5) << "Removing line Nr. " << line->Nr << "." << endl;
     1779    Log() << Verbose(0) << "Removing line Nr. " << line->Nr << "." << endl;
    14401780  delete(line);
    14411781};
     
    14481788void Tesselation::RemoveTesselationPoint(class BoundaryPointSet *point)
    14491789{
     1790        Info FunctionInfo(__func__);
    14501791  if (point == NULL)
    14511792    return;
    14521793  if (PointsOnBoundary.erase(point->Nr))
    1453     Log() << Verbose(5) << "Removing point Nr. " << point->Nr << "." << endl;
     1794    Log() << Verbose(0) << "Removing point Nr. " << point->Nr << "." << endl;
    14541795  delete(point);
    14551796};
     
    14661807int Tesselation::CheckPresenceOfTriangle(TesselPoint *Candidates[3]) const
    14671808{
     1809        Info FunctionInfo(__func__);
    14681810  int adjacentTriangleCount = 0;
    14691811  class BoundaryPointSet *Points[3];
    14701812
    1471   Log() << Verbose(2) << "Begin of CheckPresenceOfTriangle" << endl;
    14721813  // builds a triangle point set (Points) of the end points
    14731814  for (int i = 0; i < 3; i++) {
     
    14881829          for (; (FindLine != Points[i]->lines.end()) && (FindLine->first == Points[j]->node->nr); FindLine++) {
    14891830            TriangleMap *triangles = &FindLine->second->triangles;
    1490             Log() << Verbose(3) << "Current line is " << FindLine->first << ": " << *(FindLine->second) << " with triangles " << triangles << "." << endl;
     1831            Log() << Verbose(1) << "Current line is " << FindLine->first << ": " << *(FindLine->second) << " with triangles " << triangles << "." << endl;
    14911832            for (TriangleMap::const_iterator FindTriangle = triangles->begin(); FindTriangle != triangles->end(); FindTriangle++) {
    14921833              if (FindTriangle->second->IsPresentTupel(Points)) {
     
    14941835              }
    14951836            }
    1496             Log() << Verbose(3) << "end." << endl;
     1837            Log() << Verbose(1) << "end." << endl;
    14971838          }
    14981839          // Only one of the triangle lines must be considered for the triangle count.
    1499           //Log() << Verbose(2) << "Found " << adjacentTriangleCount << " adjacent triangles for the point set." << endl;
     1840          //Log() << Verbose(0) << "Found " << adjacentTriangleCount << " adjacent triangles for the point set." << endl;
    15001841          //return adjacentTriangleCount;
    15011842        }
     
    15041845  }
    15051846
    1506   Log() << Verbose(2) << "Found " << adjacentTriangleCount << " adjacent triangles for the point set." << endl;
    1507   Log() << Verbose(2) << "End of CheckPresenceOfTriangle" << endl;
     1847  Log() << Verbose(0) << "Found " << adjacentTriangleCount << " adjacent triangles for the point set." << endl;
    15081848  return adjacentTriangleCount;
    15091849};
     
    15191859class BoundaryTriangleSet * Tesselation::GetPresentTriangle(TesselPoint *Candidates[3])
    15201860{
     1861        Info FunctionInfo(__func__);
    15211862  class BoundaryTriangleSet *triangle = NULL;
    15221863  class BoundaryPointSet *Points[3];
     
    15481889          }
    15491890          // Only one of the triangle lines must be considered for the triangle count.
    1550           //Log() << Verbose(2) << "Found " << adjacentTriangleCount << " adjacent triangles for the point set." << endl;
     1891          //Log() << Verbose(0) << "Found " << adjacentTriangleCount << " adjacent triangles for the point set." << endl;
    15511892          //return adjacentTriangleCount;
    15521893        }
     
    15691910void Tesselation::FindStartingTriangle(const double RADIUS, const LinkedCell *LC)
    15701911{
    1571   Log() << Verbose(1) << "Begin of FindStartingTriangle\n";
     1912        Info FunctionInfo(__func__);
    15721913  int i = 0;
    1573   TesselPoint* FirstPoint = NULL;
    1574   TesselPoint* SecondPoint = NULL;
    15751914  TesselPoint* MaxPoint[NDIM];
     1915  TesselPoint* Temporary;
    15761916  double maxCoordinate[NDIM];
    1577   Vector Oben;
     1917  BoundaryLineSet BaseLine;
    15781918  Vector helper;
    15791919  Vector Chord;
    15801920  Vector SearchDirection;
    1581 
    1582   Oben.Zero();
     1921  Vector CircleCenter;  // center of the circle, i.e. of the band of sphere's centers
     1922  Vector CirclePlaneNormal; // normal vector defining the plane this circle lives in
     1923  Vector SphereCenter;
     1924  Vector NormalVector;
     1925
     1926  NormalVector.Zero();
    15831927
    15841928  for (i = 0; i < 3; i++) {
     
    15931937      for (LC->n[(i+2)%NDIM]=0;LC->n[(i+2)%NDIM]<LC->N[(i+2)%NDIM];LC->n[(i+2)%NDIM]++) {
    15941938        const LinkedNodes *List = LC->GetCurrentCell();
    1595         //Log() << Verbose(2) << "Current cell is " << LC->n[0] << ", " << LC->n[1] << ", " << LC->n[2] << " with No. " << LC->index << "." << endl;
     1939        //Log() << Verbose(1) << "Current cell is " << LC->n[0] << ", " << LC->n[1] << ", " << LC->n[2] << " with No. " << LC->index << "." << endl;
    15961940        if (List != NULL) {
    15971941          for (LinkedNodes::const_iterator Runner = List->begin();Runner != List->end();Runner++) {
    15981942            if ((*Runner)->node->x[i] > maxCoordinate[i]) {
    1599               Log() << Verbose(2) << "New maximal for axis " << i << " node is " << *(*Runner) << " at " << *(*Runner)->node << "." << endl;
     1943              Log() << Verbose(1) << "New maximal for axis " << i << " node is " << *(*Runner) << " at " << *(*Runner)->node << "." << endl;
    16001944              maxCoordinate[i] = (*Runner)->node->x[i];
    16011945              MaxPoint[i] = (*Runner);
     
    16081952  }
    16091953
    1610   Log() << Verbose(2) << "Found maximum coordinates: ";
     1954  Log() << Verbose(1) << "Found maximum coordinates: ";
    16111955  for (int i=0;i<NDIM;i++)
    16121956    Log() << Verbose(0) << i << ": " << *MaxPoint[i] << "\t";
     
    16141958
    16151959  BTS = NULL;
    1616   CandidateList *OptCandidates = new CandidateList();
    16171960  for (int k=0;k<NDIM;k++) {
    1618     Oben.Zero();
    1619     Oben.x[k] = 1.;
    1620     FirstPoint = MaxPoint[k];
    1621     Log() << Verbose(1) << "Coordinates of start node at " << *FirstPoint->node << "." << endl;
     1961    NormalVector.Zero();
     1962    NormalVector.x[k] = 1.;
     1963    BaseLine.endpoints[0] = new BoundaryPointSet(MaxPoint[k]);
     1964    Log() << Verbose(0) << "Coordinates of start node at " << *BaseLine.endpoints[0]->node << "." << endl;
    16221965
    16231966    double ShortestAngle;
    1624     TesselPoint* OptCandidate = NULL;
    16251967    ShortestAngle = 999999.; // This will contain the angle, which will be always positive (when looking for second point), when looking for third point this will be the quadrant.
    16261968
    1627     FindSecondPointForTesselation(FirstPoint, Oben, OptCandidate, &ShortestAngle, RADIUS, LC); // we give same point as next candidate as its bonds are looked into in find_second_...
    1628     SecondPoint = OptCandidate;
    1629     if (SecondPoint == NULL)  // have we found a second point?
     1969    FindSecondPointForTesselation(BaseLine.endpoints[0]->node, NormalVector, Temporary, &ShortestAngle, RADIUS, LC); // we give same point as next candidate as its bonds are looked into in find_second_...
     1970    if (Temporary == NULL)  // have we found a second point?
    16301971      continue;
    1631 
    1632     helper.CopyVector(FirstPoint->node);
    1633     helper.SubtractVector(SecondPoint->node);
    1634     helper.Normalize();
    1635     Oben.ProjectOntoPlane(&helper);
    1636     Oben.Normalize();
    1637     helper.VectorProduct(&Oben);
     1972    BaseLine.endpoints[1] = new BoundaryPointSet(Temporary);
     1973
     1974    // construct center of circle
     1975    CircleCenter.CopyVector(BaseLine.endpoints[0]->node->node);
     1976    CircleCenter.AddVector(BaseLine.endpoints[1]->node->node);
     1977    CircleCenter.Scale(0.5);
     1978
     1979    // construct normal vector of circle
     1980    CirclePlaneNormal.CopyVector(BaseLine.endpoints[0]->node->node);
     1981    CirclePlaneNormal.SubtractVector(BaseLine.endpoints[1]->node->node);
     1982
     1983    double radius = CirclePlaneNormal.NormSquared();
     1984    double CircleRadius = sqrt(RADIUS*RADIUS - radius/4.);
     1985
     1986    NormalVector.ProjectOntoPlane(&CirclePlaneNormal);
     1987    NormalVector.Normalize();
    16381988    ShortestAngle = 2.*M_PI; // This will indicate the quadrant.
    16391989
    1640     Chord.CopyVector(FirstPoint->node); // bring into calling function
    1641     Chord.SubtractVector(SecondPoint->node);
    1642     double radius = Chord.ScalarProduct(&Chord);
    1643     double CircleRadius = sqrt(RADIUS*RADIUS - radius/4.);
    1644     helper.CopyVector(&Oben);
    1645     helper.Scale(CircleRadius);
    1646     // Now, oben and helper are two orthonormalized vectors in the plane defined by Chord (not normalized)
     1990    SphereCenter.CopyVector(&NormalVector);
     1991    SphereCenter.Scale(CircleRadius);
     1992    SphereCenter.AddVector(&CircleCenter);
     1993    // Now, NormalVector and SphereCenter are two orthonormalized vectors in the plane defined by CirclePlaneNormal (not normalized)
    16471994
    16481995    // look in one direction of baseline for initial candidate
    1649     SearchDirection.MakeNormalVector(&Chord, &Oben);  // whether we look "left" first or "right" first is not important ...
     1996    SearchDirection.MakeNormalVector(&CirclePlaneNormal, &NormalVector);  // whether we look "left" first or "right" first is not important ...
    16501997
    16511998    // adding point 1 and point 2 and add the line between them
    1652     Log() << Verbose(1) << "Coordinates of start node at " << *FirstPoint->node << "." << endl;
    1653     AddTesselationPoint(FirstPoint, 0);
    1654     Log() << Verbose(1) << "Found second point is at " << *SecondPoint->node << ".\n";
    1655     AddTesselationPoint(SecondPoint, 1);
    1656     AddTesselationLine(TPS[0], TPS[1], 0);
    1657 
    1658     //Log() << Verbose(2) << "INFO: OldSphereCenter is at " << helper << ".\n";
    1659     FindThirdPointForTesselation(Oben, SearchDirection, helper, BLS[0], NULL, *&OptCandidates, &ShortestAngle, RADIUS, LC);
    1660     Log() << Verbose(1) << "List of third Points is ";
    1661     for (CandidateList::iterator it = OptCandidates->begin(); it != OptCandidates->end(); ++it) {
    1662         Log() << Verbose(0) << " " << *(*it)->point;
    1663     }
    1664     Log() << Verbose(0) << endl;
    1665 
    1666     for (CandidateList::iterator it = OptCandidates->begin(); it != OptCandidates->end(); ++it) {
    1667       // add third triangle point
    1668       AddTesselationPoint((*it)->point, 2);
    1669       // add the second and third line
    1670       AddTesselationLine(TPS[1], TPS[2], 1);
    1671       AddTesselationLine(TPS[0], TPS[2], 2);
    1672       // ... and triangles to the Maps of the Tesselation class
    1673       BTS = new class BoundaryTriangleSet(BLS, TrianglesOnBoundaryCount);
    1674       AddTesselationTriangle();
    1675       // ... and calculate its normal vector (with correct orientation)
    1676       (*it)->OptCenter.Scale(-1.);
    1677       Log() << Verbose(2) << "Anti-Oben is currently " << (*it)->OptCenter << "." << endl;
    1678       BTS->GetNormalVector((*it)->OptCenter);  // vector to compare with should point inwards
    1679       Log() << Verbose(0) << "==> Found starting triangle consists of " << *FirstPoint << ", " << *SecondPoint << " and "
    1680       << *(*it)->point << " with normal vector " << BTS->NormalVector << ".\n";
    1681 
    1682       // if we do not reach the end with the next step of iteration, we need to setup a new first line
    1683       if (it != OptCandidates->end()--) {
    1684         FirstPoint = (*it)->BaseLine->endpoints[0]->node;
    1685         SecondPoint = (*it)->point;
    1686         // adding point 1 and point 2 and the line between them
    1687         AddTesselationPoint(FirstPoint, 0);
    1688         AddTesselationPoint(SecondPoint, 1);
    1689         AddTesselationLine(TPS[0], TPS[1], 0);
    1690       }
    1691       Log() << Verbose(2) << "Projection is " << BTS->NormalVector.ScalarProduct(&Oben) << "." << endl;
    1692     }
     1999    Log() << Verbose(0) << "Coordinates of start node at " << *BaseLine.endpoints[0]->node << "." << endl;
     2000    Log() << Verbose(0) << "Found second point is at " << *BaseLine.endpoints[1]->node << ".\n";
     2001
     2002    //Log() << Verbose(1) << "INFO: OldSphereCenter is at " << helper << ".\n";
     2003    CandidateForTesselation OptCandidates(&BaseLine);
     2004    FindThirdPointForTesselation(NormalVector, SearchDirection, SphereCenter, OptCandidates, NULL, RADIUS, LC);
     2005    Log() << Verbose(0) << "List of third Points is:" << endl;
     2006    for (TesselPointList::iterator it = OptCandidates.pointlist.begin(); it != OptCandidates.pointlist.end(); it++) {
     2007        Log() << Verbose(0) << " " << *(*it) << endl;
     2008    }
     2009
     2010    BTS = NULL;
     2011    AddCandidateTriangle(OptCandidates);
     2012//    delete(BaseLine.endpoints[0]);
     2013//    delete(BaseLine.endpoints[1]);
     2014
    16932015    if (BTS != NULL) // we have created one starting triangle
    16942016      break;
    16952017    else {
    16962018      // remove all candidates from the list and then the list itself
    1697       class CandidateForTesselation *remover = NULL;
    1698       for (CandidateList::iterator it = OptCandidates->begin(); it != OptCandidates->end(); ++it) {
    1699         remover = *it;
    1700         delete(remover);
    1701       }
    1702       OptCandidates->clear();
    1703     }
    1704   }
    1705 
    1706   // remove all candidates from the list and then the list itself
    1707   class CandidateForTesselation *remover = NULL;
    1708   for (CandidateList::iterator it = OptCandidates->begin(); it != OptCandidates->end(); ++it) {
    1709     remover = *it;
    1710     delete(remover);
    1711   }
    1712   delete(OptCandidates);
    1713   Log() << Verbose(1) << "End of FindStartingTriangle\n";
     2019      OptCandidates.pointlist.clear();
     2020    }
     2021  }
    17142022};
    17152023
    17162024/** Checks for a given baseline and a third point candidate whether baselines of the found triangle don't have even better candidates.
    17172025 * This is supposed to prevent early closing of the tesselation.
    1718  * \param *BaseRay baseline, i.e. not \a *OptCandidate
     2026 * \param CandidateLine CandidateForTesselation with baseline and shortestangle , i.e. not \a *OptCandidate
    17192027 * \param *ThirdNode third point in triangle, not in BoundaryLineSet::endpoints
    1720  * \param ShortestAngle path length on this circle band for the current \a *ThirdNode
    17212028 * \param RADIUS radius of sphere
    17222029 * \param *LC LinkedCell structure
    17232030 * \return true - there is a better candidate (smaller angle than \a ShortestAngle), false - no better TesselPoint candidate found
    17242031 */
    1725 bool Tesselation::HasOtherBaselineBetterCandidate(const BoundaryLineSet * const BaseRay, const TesselPoint * const ThirdNode, double ShortestAngle, double RADIUS, const LinkedCell * const LC) const
    1726 {
    1727   bool result = false;
    1728   Vector CircleCenter;
    1729   Vector CirclePlaneNormal;
    1730   Vector OldSphereCenter;
    1731   Vector SearchDirection;
    1732   Vector helper;
    1733   TesselPoint *OtherOptCandidate = NULL;
    1734   double OtherShortestAngle = 2.*M_PI; // This will indicate the quadrant.
    1735   double radius, CircleRadius;
    1736   BoundaryLineSet *Line = NULL;
    1737   BoundaryTriangleSet *T = NULL;
    1738 
    1739   Log() << Verbose(1) << "Begin of HasOtherBaselineBetterCandidate" << endl;
    1740 
    1741   // check both other lines
    1742   PointMap::const_iterator FindPoint = PointsOnBoundary.find(ThirdNode->nr);
    1743   if (FindPoint != PointsOnBoundary.end()) {
    1744     for (int i=0;i<2;i++) {
    1745       LineMap::const_iterator FindLine = (FindPoint->second)->lines.find(BaseRay->endpoints[0]->node->nr);
    1746       if (FindLine != (FindPoint->second)->lines.end()) {
    1747         Line = FindLine->second;
    1748         Log() << Verbose(1) << "Found line " << *Line << "." << endl;
    1749         if (Line->triangles.size() == 1) {
    1750           T = Line->triangles.begin()->second;
    1751           // construct center of circle
    1752           CircleCenter.CopyVector(Line->endpoints[0]->node->node);
    1753           CircleCenter.AddVector(Line->endpoints[1]->node->node);
    1754           CircleCenter.Scale(0.5);
    1755 
    1756           // construct normal vector of circle
    1757           CirclePlaneNormal.CopyVector(Line->endpoints[0]->node->node);
    1758           CirclePlaneNormal.SubtractVector(Line->endpoints[1]->node->node);
    1759 
    1760           // calculate squared radius of circle
    1761           radius = CirclePlaneNormal.ScalarProduct(&CirclePlaneNormal);
    1762           if (radius/4. < RADIUS*RADIUS) {
    1763             CircleRadius = RADIUS*RADIUS - radius/4.;
    1764             CirclePlaneNormal.Normalize();
    1765             //Log() << Verbose(2) << "INFO: CircleCenter is at " << CircleCenter << ", CirclePlaneNormal is " << CirclePlaneNormal << " with circle radius " << sqrt(CircleRadius) << "." << endl;
    1766 
    1767             // construct old center
    1768             GetCenterofCircumcircle(&OldSphereCenter, *T->endpoints[0]->node->node, *T->endpoints[1]->node->node, *T->endpoints[2]->node->node);
    1769             helper.CopyVector(&T->NormalVector);  // normal vector ensures that this is correct center of the two possible ones
    1770             radius = Line->endpoints[0]->node->node->DistanceSquared(&OldSphereCenter);
    1771             helper.Scale(sqrt(RADIUS*RADIUS - radius));
    1772             OldSphereCenter.AddVector(&helper);
    1773             OldSphereCenter.SubtractVector(&CircleCenter);
    1774             //Log() << Verbose(2) << "INFO: OldSphereCenter is at " << OldSphereCenter << "." << endl;
    1775 
    1776             // construct SearchDirection
    1777             SearchDirection.MakeNormalVector(&T->NormalVector, &CirclePlaneNormal);
    1778             helper.CopyVector(Line->endpoints[0]->node->node);
    1779             helper.SubtractVector(ThirdNode->node);
    1780             if (helper.ScalarProduct(&SearchDirection) < -HULLEPSILON)// ohoh, SearchDirection points inwards!
    1781               SearchDirection.Scale(-1.);
    1782             SearchDirection.ProjectOntoPlane(&OldSphereCenter);
    1783             SearchDirection.Normalize();
    1784             Log() << Verbose(2) << "INFO: SearchDirection is " << SearchDirection << "." << endl;
    1785             if (fabs(OldSphereCenter.ScalarProduct(&SearchDirection)) > HULLEPSILON) {
    1786               // rotated the wrong way!
    1787               eLog() << Verbose(1) << "SearchDirection and RelativeOldSphereCenter are still not orthogonal!" << endl;
    1788             }
    1789 
    1790             // add third point
    1791             CandidateList *OptCandidates = new CandidateList();
    1792             FindThirdPointForTesselation(T->NormalVector, SearchDirection, OldSphereCenter, Line, ThirdNode, OptCandidates, &OtherShortestAngle, RADIUS, LC);
    1793             for (CandidateList::iterator it = OptCandidates->begin(); it != OptCandidates->end(); ++it) {
    1794               if (((*it)->point == BaseRay->endpoints[0]->node) || ((*it)->point == BaseRay->endpoints[1]->node)) // skip if it's the same triangle than suggested
    1795                 continue;
    1796               Log() << Verbose(1) << " Third point candidate is " << *(*it)->point
    1797               << " with circumsphere's center at " << (*it)->OptCenter << "." << endl;
    1798               Log() << Verbose(1) << " Baseline is " << *BaseRay << endl;
    1799 
    1800               // check whether all edges of the new triangle still have space for one more triangle (i.e. TriangleCount <2)
    1801               TesselPoint *PointCandidates[3];
    1802               PointCandidates[0] = (*it)->point;
    1803               PointCandidates[1] = BaseRay->endpoints[0]->node;
    1804               PointCandidates[2] = BaseRay->endpoints[1]->node;
    1805               bool check=false;
    1806               int existentTrianglesCount = CheckPresenceOfTriangle(PointCandidates);
    1807               // If there is no triangle, add it regularly.
    1808               if (existentTrianglesCount == 0) {
    1809                 SetTesselationPoint((*it)->point, 0);
    1810                 SetTesselationPoint(BaseRay->endpoints[0]->node, 1);
    1811                 SetTesselationPoint(BaseRay->endpoints[1]->node, 2);
    1812 
    1813                 if (CheckLineCriteriaForDegeneratedTriangle((const BoundaryPointSet ** const )TPS)) {
    1814                   OtherOptCandidate = (*it)->point;
    1815                   check = true;
    1816                 }
    1817               } else if ((existentTrianglesCount >= 1) && (existentTrianglesCount <= 3)) { // If there is a planar region within the structure, we need this triangle a second time.
    1818                 SetTesselationPoint((*it)->point, 0);
    1819                 SetTesselationPoint(BaseRay->endpoints[0]->node, 1);
    1820                 SetTesselationPoint(BaseRay->endpoints[1]->node, 2);
    1821 
    1822                 // We demand that at most one new degenerate line is created and that this line also already exists (which has to be the case due to existentTrianglesCount == 1)
    1823                 // i.e. at least one of the three lines must be present with TriangleCount <= 1
    1824                 if (CheckLineCriteriaForDegeneratedTriangle((const BoundaryPointSet ** const)TPS)) {
    1825                   OtherOptCandidate = (*it)->point;
    1826                   check = true;
    1827                 }
    1828               }
    1829 
    1830               if (check) {
    1831                 if (ShortestAngle > OtherShortestAngle) {
    1832                   Log() << Verbose(1) << "There is a better candidate than " << *ThirdNode << " with " << ShortestAngle << " from baseline " << *Line << ": " << *OtherOptCandidate << " with " << OtherShortestAngle << "." << endl;
    1833                   result = true;
    1834                   break;
    1835                 }
    1836               }
    1837             }
    1838             delete(OptCandidates);
    1839             if (result)
    1840               break;
    1841           } else {
    1842             Log() << Verbose(1) << "Circumcircle for base line " << *Line << " and base triangle " << T << " is too big!" << endl;
    1843           }
    1844         } else {
    1845           eLog() << Verbose(2) << "Baseline is connected to two triangles already?" << endl;
    1846         }
    1847       } else {
    1848         Log() << Verbose(2) << "No present baseline between " << BaseRay->endpoints[0] << " and candidate " << *ThirdNode << "." << endl;
    1849       }
    1850     }
    1851   } else {
    1852     eLog() << Verbose(1) << "Could not find the TesselPoint " << *ThirdNode << "." << endl;
    1853   }
    1854 
    1855   Log() << Verbose(1) << "End of HasOtherBaselineBetterCandidate" << endl;
    1856 
    1857   return result;
    1858 };
     2032//bool Tesselation::HasOtherBaselineBetterCandidate(CandidateForTesselation &CandidateLine, const TesselPoint * const ThirdNode, double RADIUS, const LinkedCell * const LC) const
     2033//{
     2034//      Info FunctionInfo(__func__);
     2035//  bool result = false;
     2036//  Vector CircleCenter;
     2037//  Vector CirclePlaneNormal;
     2038//  Vector OldSphereCenter;
     2039//  Vector SearchDirection;
     2040//  Vector helper;
     2041//  TesselPoint *OtherOptCandidate = NULL;
     2042//  double OtherShortestAngle = 2.*M_PI; // This will indicate the quadrant.
     2043//  double radius, CircleRadius;
     2044//  BoundaryLineSet *Line = NULL;
     2045//  BoundaryTriangleSet *T = NULL;
     2046//
     2047//  // check both other lines
     2048//  PointMap::const_iterator FindPoint = PointsOnBoundary.find(ThirdNode->nr);
     2049//  if (FindPoint != PointsOnBoundary.end()) {
     2050//    for (int i=0;i<2;i++) {
     2051//      LineMap::const_iterator FindLine = (FindPoint->second)->lines.find(BaseRay->endpoints[0]->node->nr);
     2052//      if (FindLine != (FindPoint->second)->lines.end()) {
     2053//        Line = FindLine->second;
     2054//        Log() << Verbose(0) << "Found line " << *Line << "." << endl;
     2055//        if (Line->triangles.size() == 1) {
     2056//          T = Line->triangles.begin()->second;
     2057//          // construct center of circle
     2058//          CircleCenter.CopyVector(Line->endpoints[0]->node->node);
     2059//          CircleCenter.AddVector(Line->endpoints[1]->node->node);
     2060//          CircleCenter.Scale(0.5);
     2061//
     2062//          // construct normal vector of circle
     2063//          CirclePlaneNormal.CopyVector(Line->endpoints[0]->node->node);
     2064//          CirclePlaneNormal.SubtractVector(Line->endpoints[1]->node->node);
     2065//
     2066//          // calculate squared radius of circle
     2067//          radius = CirclePlaneNormal.ScalarProduct(&CirclePlaneNormal);
     2068//          if (radius/4. < RADIUS*RADIUS) {
     2069//            CircleRadius = RADIUS*RADIUS - radius/4.;
     2070//            CirclePlaneNormal.Normalize();
     2071//            //Log() << Verbose(1) << "INFO: CircleCenter is at " << CircleCenter << ", CirclePlaneNormal is " << CirclePlaneNormal << " with circle radius " << sqrt(CircleRadius) << "." << endl;
     2072//
     2073//            // construct old center
     2074//            GetCenterofCircumcircle(&OldSphereCenter, *T->endpoints[0]->node->node, *T->endpoints[1]->node->node, *T->endpoints[2]->node->node);
     2075//            helper.CopyVector(&T->NormalVector);  // normal vector ensures that this is correct center of the two possible ones
     2076//            radius = Line->endpoints[0]->node->node->DistanceSquared(&OldSphereCenter);
     2077//            helper.Scale(sqrt(RADIUS*RADIUS - radius));
     2078//            OldSphereCenter.AddVector(&helper);
     2079//            OldSphereCenter.SubtractVector(&CircleCenter);
     2080//            //Log() << Verbose(1) << "INFO: OldSphereCenter is at " << OldSphereCenter << "." << endl;
     2081//
     2082//            // construct SearchDirection
     2083//            SearchDirection.MakeNormalVector(&T->NormalVector, &CirclePlaneNormal);
     2084//            helper.CopyVector(Line->endpoints[0]->node->node);
     2085//            helper.SubtractVector(ThirdNode->node);
     2086//            if (helper.ScalarProduct(&SearchDirection) < -HULLEPSILON)// ohoh, SearchDirection points inwards!
     2087//              SearchDirection.Scale(-1.);
     2088//            SearchDirection.ProjectOntoPlane(&OldSphereCenter);
     2089//            SearchDirection.Normalize();
     2090//            Log() << Verbose(1) << "INFO: SearchDirection is " << SearchDirection << "." << endl;
     2091//            if (fabs(OldSphereCenter.ScalarProduct(&SearchDirection)) > HULLEPSILON) {
     2092//              // rotated the wrong way!
     2093//              eLog() << Verbose(1) << "SearchDirection and RelativeOldSphereCenter are still not orthogonal!" << endl;
     2094//            }
     2095//
     2096//            // add third point
     2097//            FindThirdPointForTesselation(T->NormalVector, SearchDirection, OldSphereCenter, OptCandidates, ThirdNode, RADIUS, LC);
     2098//            for (TesselPointList::iterator it = OptCandidates.pointlist.begin(); it != OptCandidates.pointlist.end(); ++it) {
     2099//              if (((*it) == BaseRay->endpoints[0]->node) || ((*it) == BaseRay->endpoints[1]->node)) // skip if it's the same triangle than suggested
     2100//                continue;
     2101//              Log() << Verbose(0) << " Third point candidate is " << (*it)
     2102//              << " with circumsphere's center at " << (*it)->OptCenter << "." << endl;
     2103//              Log() << Verbose(0) << " Baseline is " << *BaseRay << endl;
     2104//
     2105//              // check whether all edges of the new triangle still have space for one more triangle (i.e. TriangleCount <2)
     2106//              TesselPoint *PointCandidates[3];
     2107//              PointCandidates[0] = (*it);
     2108//              PointCandidates[1] = BaseRay->endpoints[0]->node;
     2109//              PointCandidates[2] = BaseRay->endpoints[1]->node;
     2110//              bool check=false;
     2111//              int existentTrianglesCount = CheckPresenceOfTriangle(PointCandidates);
     2112//              // If there is no triangle, add it regularly.
     2113//              if (existentTrianglesCount == 0) {
     2114//                SetTesselationPoint((*it), 0);
     2115//                SetTesselationPoint(BaseRay->endpoints[0]->node, 1);
     2116//                SetTesselationPoint(BaseRay->endpoints[1]->node, 2);
     2117//
     2118//                if (CheckLineCriteriaForDegeneratedTriangle((const BoundaryPointSet ** const )TPS)) {
     2119//                  OtherOptCandidate = (*it);
     2120//                  check = true;
     2121//                }
     2122//              } else if ((existentTrianglesCount >= 1) && (existentTrianglesCount <= 3)) { // If there is a planar region within the structure, we need this triangle a second time.
     2123//                SetTesselationPoint((*it), 0);
     2124//                SetTesselationPoint(BaseRay->endpoints[0]->node, 1);
     2125//                SetTesselationPoint(BaseRay->endpoints[1]->node, 2);
     2126//
     2127//                // We demand that at most one new degenerate line is created and that this line also already exists (which has to be the case due to existentTrianglesCount == 1)
     2128//                // i.e. at least one of the three lines must be present with TriangleCount <= 1
     2129//                if (CheckLineCriteriaForDegeneratedTriangle((const BoundaryPointSet ** const)TPS)) {
     2130//                  OtherOptCandidate = (*it);
     2131//                  check = true;
     2132//                }
     2133//              }
     2134//
     2135//              if (check) {
     2136//                if (ShortestAngle > OtherShortestAngle) {
     2137//                  Log() << Verbose(0) << "There is a better candidate than " << *ThirdNode << " with " << ShortestAngle << " from baseline " << *Line << ": " << *OtherOptCandidate << " with " << OtherShortestAngle << "." << endl;
     2138//                  result = true;
     2139//                  break;
     2140//                }
     2141//              }
     2142//            }
     2143//            delete(OptCandidates);
     2144//            if (result)
     2145//              break;
     2146//          } else {
     2147//            Log() << Verbose(0) << "Circumcircle for base line " << *Line << " and base triangle " << T << " is too big!" << endl;
     2148//          }
     2149//        } else {
     2150//          eLog() << Verbose(2) << "Baseline is connected to two triangles already?" << endl;
     2151//        }
     2152//      } else {
     2153//        Log() << Verbose(1) << "No present baseline between " << BaseRay->endpoints[0] << " and candidate " << *ThirdNode << "." << endl;
     2154//      }
     2155//    }
     2156//  } else {
     2157//    eLog() << Verbose(1) << "Could not find the TesselPoint " << *ThirdNode << "." << endl;
     2158//  }
     2159//
     2160//  return result;
     2161//};
    18592162
    18602163/** This function finds a triangle to a line, adjacent to an existing one.
    18612164 * @param out output stream for debugging
    1862  * @param Line current baseline to search from
     2165 * @param CandidateLine current cadndiate baseline to search from
    18632166 * @param T current triangle which \a Line is edge of
    18642167 * @param RADIUS radius of the rolling ball
     
    18662169 * @param *LC LinkedCell structure with neighbouring points
    18672170 */
    1868 bool Tesselation::FindNextSuitableTriangle(BoundaryLineSet &Line, BoundaryTriangleSet &T, const double& RADIUS, const LinkedCell *LC)
    1869 {
    1870   Log() << Verbose(0) << "Begin of FindNextSuitableTriangle\n";
     2171bool Tesselation::FindNextSuitableTriangle(CandidateForTesselation &CandidateLine, BoundaryTriangleSet &T, const double& RADIUS, const LinkedCell *LC)
     2172{
     2173        Info FunctionInfo(__func__);
    18712174  bool result = true;
    1872   CandidateList *OptCandidates = new CandidateList();
    18732175
    18742176  Vector CircleCenter;
    18752177  Vector CirclePlaneNormal;
    1876   Vector OldSphereCenter;
     2178  Vector RelativeSphereCenter;
    18772179  Vector SearchDirection;
    18782180  Vector helper;
    18792181  TesselPoint *ThirdNode = NULL;
    18802182  LineMap::iterator testline;
    1881   double ShortestAngle = 2.*M_PI; // This will indicate the quadrant.
    18822183  double radius, CircleRadius;
    18832184
    1884   Log() << Verbose(1) << "Current baseline is " << Line << " of triangle " << T << "." << endl;
    18852185  for (int i=0;i<3;i++)
    1886     if ((T.endpoints[i]->node != Line.endpoints[0]->node) && (T.endpoints[i]->node != Line.endpoints[1]->node))
     2186    if ((T.endpoints[i]->node != CandidateLine.BaseLine->endpoints[0]->node) && (T.endpoints[i]->node != CandidateLine.BaseLine->endpoints[1]->node)) {
    18872187      ThirdNode = T.endpoints[i]->node;
     2188      break;
     2189    }
     2190  Log() << Verbose(0) << "Current baseline is " << *CandidateLine.BaseLine << " with ThirdNode " << *ThirdNode << " of triangle " << T << "." << endl;
    18882191
    18892192  // construct center of circle
    1890   CircleCenter.CopyVector(Line.endpoints[0]->node->node);
    1891   CircleCenter.AddVector(Line.endpoints[1]->node->node);
     2193  CircleCenter.CopyVector(CandidateLine.BaseLine->endpoints[0]->node->node);
     2194  CircleCenter.AddVector(CandidateLine.BaseLine->endpoints[1]->node->node);
    18922195  CircleCenter.Scale(0.5);
    18932196
    18942197  // construct normal vector of circle
    1895   CirclePlaneNormal.CopyVector(Line.endpoints[0]->node->node);
    1896   CirclePlaneNormal.SubtractVector(Line.endpoints[1]->node->node);
     2198  CirclePlaneNormal.CopyVector(CandidateLine.BaseLine->endpoints[0]->node->node);
     2199  CirclePlaneNormal.SubtractVector(CandidateLine.BaseLine->endpoints[1]->node->node);
    18972200
    18982201  // calculate squared radius of circle
    18992202  radius = CirclePlaneNormal.ScalarProduct(&CirclePlaneNormal);
    19002203  if (radius/4. < RADIUS*RADIUS) {
     2204    // construct relative sphere center with now known CircleCenter
     2205    RelativeSphereCenter.CopyVector(&T.SphereCenter);
     2206    RelativeSphereCenter.SubtractVector(&CircleCenter);
     2207
    19012208    CircleRadius = RADIUS*RADIUS - radius/4.;
    19022209    CirclePlaneNormal.Normalize();
    1903     //Log() << Verbose(2) << "INFO: CircleCenter is at " << CircleCenter << ", CirclePlaneNormal is " << CirclePlaneNormal << " with circle radius " << sqrt(CircleRadius) << "." << endl;
    1904 
    1905     // construct old center
    1906     GetCenterofCircumcircle(&OldSphereCenter, *T.endpoints[0]->node->node, *T.endpoints[1]->node->node, *T.endpoints[2]->node->node);
    1907     helper.CopyVector(&T.NormalVector);  // normal vector ensures that this is correct center of the two possible ones
    1908     radius = Line.endpoints[0]->node->node->DistanceSquared(&OldSphereCenter);
    1909     helper.Scale(sqrt(RADIUS*RADIUS - radius));
    1910     OldSphereCenter.AddVector(&helper);
    1911     OldSphereCenter.SubtractVector(&CircleCenter);
    1912     //Log() << Verbose(2) << "INFO: OldSphereCenter is at " << OldSphereCenter << "." << endl;
    1913 
    1914     // construct SearchDirection
    1915     SearchDirection.MakeNormalVector(&T.NormalVector, &CirclePlaneNormal);
    1916     helper.CopyVector(Line.endpoints[0]->node->node);
     2210    Log() << Verbose(1) << "INFO: CircleCenter is at " << CircleCenter << ", CirclePlaneNormal is " << CirclePlaneNormal << " with circle radius " << sqrt(CircleRadius) << "." << endl;
     2211
     2212    Log() << Verbose(1) << "INFO: OldSphereCenter is at " << T.SphereCenter << "." << endl;
     2213
     2214    // construct SearchDirection and an "outward pointer"
     2215    SearchDirection.MakeNormalVector(&RelativeSphereCenter, &CirclePlaneNormal);
     2216    helper.CopyVector(&CircleCenter);
    19172217    helper.SubtractVector(ThirdNode->node);
    19182218    if (helper.ScalarProduct(&SearchDirection) < -HULLEPSILON)// ohoh, SearchDirection points inwards!
    19192219      SearchDirection.Scale(-1.);
    1920     SearchDirection.ProjectOntoPlane(&OldSphereCenter);
    1921     SearchDirection.Normalize();
    1922     Log() << Verbose(2) << "INFO: SearchDirection is " << SearchDirection << "." << endl;
    1923     if (fabs(OldSphereCenter.ScalarProduct(&SearchDirection)) > HULLEPSILON) {
     2220    Log() << Verbose(1) << "INFO: SearchDirection is " << SearchDirection << "." << endl;
     2221    if (fabs(RelativeSphereCenter.ScalarProduct(&SearchDirection)) > HULLEPSILON) {
    19242222      // rotated the wrong way!
    19252223      eLog() << Verbose(1) << "SearchDirection and RelativeOldSphereCenter are still not orthogonal!" << endl;
     
    19272225
    19282226    // add third point
    1929     FindThirdPointForTesselation(T.NormalVector, SearchDirection, OldSphereCenter, &Line, ThirdNode, OptCandidates, &ShortestAngle, RADIUS, LC);
     2227    FindThirdPointForTesselation(T.NormalVector, SearchDirection, T.SphereCenter, CandidateLine, ThirdNode, RADIUS, LC);
    19302228
    19312229  } else {
    1932     Log() << Verbose(1) << "Circumcircle for base line " << Line << " and base triangle " << T << " is too big!" << endl;
    1933   }
    1934 
    1935   if (OptCandidates->begin() == OptCandidates->end()) {
     2230    Log() << Verbose(0) << "Circumcircle for base line " << *CandidateLine.BaseLine << " and base triangle " << T << " is too big!" << endl;
     2231  }
     2232
     2233  if (CandidateLine.pointlist.empty()) {
    19362234    eLog() << Verbose(2) << "Could not find a suitable candidate." << endl;
    19372235    return false;
    19382236  }
    1939   Log() << Verbose(1) << "Third Points are ";
    1940   for (CandidateList::iterator it = OptCandidates->begin(); it != OptCandidates->end(); ++it) {
    1941     Log() << Verbose(1) << " " << *(*it)->point << endl;
    1942   }
    1943 
    1944   BoundaryLineSet *BaseRay = &Line;
    1945   for (CandidateList::iterator it = OptCandidates->begin(); it != OptCandidates->end(); ++it) {
    1946     Log() << Verbose(1) << " Third point candidate is " << *(*it)->point
    1947     << " with circumsphere's center at " << (*it)->OptCenter << "." << endl;
    1948     Log() << Verbose(1) << " Baseline is " << *BaseRay << endl;
    1949 
    1950     // check whether all edges of the new triangle still have space for one more triangle (i.e. TriangleCount <2)
    1951     TesselPoint *PointCandidates[3];
    1952     PointCandidates[0] = (*it)->point;
    1953     PointCandidates[1] = BaseRay->endpoints[0]->node;
    1954     PointCandidates[2] = BaseRay->endpoints[1]->node;
    1955     int existentTrianglesCount = CheckPresenceOfTriangle(PointCandidates);
    1956 
    1957     BTS = NULL;
    1958     // check for present edges and whether we reach better candidates from them
    1959     //if (HasOtherBaselineBetterCandidate(BaseRay, (*it)->point, ShortestAngle, RADIUS, LC) ) {
    1960     if (0) {
    1961       result = false;
    1962       break;
    1963     } else {
    1964       // If there is no triangle, add it regularly.
    1965       if (existentTrianglesCount == 0) {
    1966         AddTesselationPoint((*it)->point, 0);
    1967         AddTesselationPoint(BaseRay->endpoints[0]->node, 1);
    1968         AddTesselationPoint(BaseRay->endpoints[1]->node, 2);
    1969 
    1970         if (CheckLineCriteriaForDegeneratedTriangle((const BoundaryPointSet ** const )TPS)) {
    1971           AddTesselationLine(TPS[0], TPS[1], 0);
    1972           AddTesselationLine(TPS[0], TPS[2], 1);
    1973           AddTesselationLine(TPS[1], TPS[2], 2);
    1974 
    1975           BTS = new class BoundaryTriangleSet(BLS, TrianglesOnBoundaryCount);
    1976           AddTesselationTriangle();
    1977           (*it)->OptCenter.Scale(-1.);
    1978           BTS->GetNormalVector((*it)->OptCenter);
    1979           (*it)->OptCenter.Scale(-1.);
    1980 
    1981           Log() << Verbose(0) << "--> New triangle with " << *BTS << " and normal vector " << BTS->NormalVector
    1982             << " for this triangle ... " << endl;
    1983         //Log() << Verbose(1) << "We have "<< TrianglesOnBoundaryCount << " for line " << *BaseRay << "." << endl;
    1984         } else {
    1985           eLog() << Verbose(2) << "This triangle consisting of ";
    1986           Log() << Verbose(0) << *(*it)->point << ", ";
    1987           Log() << Verbose(0) << *BaseRay->endpoints[0]->node << " and ";
    1988           Log() << Verbose(0) << *BaseRay->endpoints[1]->node << " ";
    1989           Log() << Verbose(0) << "exists and is not added, as it does not seem helpful!" << endl;
    1990           result = false;
    1991         }
    1992       } else if ((existentTrianglesCount >= 1) && (existentTrianglesCount <= 3)) { // If there is a planar region within the structure, we need this triangle a second time.
    1993           AddTesselationPoint((*it)->point, 0);
    1994           AddTesselationPoint(BaseRay->endpoints[0]->node, 1);
    1995           AddTesselationPoint(BaseRay->endpoints[1]->node, 2);
    1996 
    1997           // We demand that at most one new degenerate line is created and that this line also already exists (which has to be the case due to existentTrianglesCount == 1)
    1998           // i.e. at least one of the three lines must be present with TriangleCount <= 1
    1999           if (CheckLineCriteriaForDegeneratedTriangle((const BoundaryPointSet ** const)TPS)) {
    2000             AddTesselationLine(TPS[0], TPS[1], 0);
    2001             AddTesselationLine(TPS[0], TPS[2], 1);
    2002             AddTesselationLine(TPS[1], TPS[2], 2);
    2003 
    2004             BTS = new class BoundaryTriangleSet(BLS, TrianglesOnBoundaryCount);
    2005             AddTesselationTriangle();  // add to global map
    2006 
    2007             (*it)->OtherOptCenter.Scale(-1.);
    2008             BTS->GetNormalVector((*it)->OtherOptCenter);
    2009             (*it)->OtherOptCenter.Scale(-1.);
    2010 
    2011             eLog() << Verbose(2) << "--> WARNING: Special new triangle with " << *BTS << " and normal vector " << BTS->NormalVector << " for this triangle ... " << endl;
    2012             Log() << Verbose(1) << "We have "<< BaseRay->triangles.size() << " for line " << BaseRay << "." << endl;
    2013           } else {
    2014             eLog() << Verbose(2) << "This triangle consisting of " << *(*it)->point << ", " << *BaseRay->endpoints[0]->node << " and " << *BaseRay->endpoints[1]->node << " " << "exists and is not added, as it does not seem helpful!" << endl;
    2015             result = false;
    2016           }
    2017       } else {
    2018         Log() << Verbose(1) << "This triangle consisting of ";
    2019         Log() << Verbose(0) << *(*it)->point << ", ";
    2020         Log() << Verbose(0) << *BaseRay->endpoints[0]->node << " and ";
    2021         Log() << Verbose(0) << *BaseRay->endpoints[1]->node << " ";
    2022         Log() << Verbose(0) << "is invalid!" << endl;
    2023         result = false;
    2024       }
    2025     }
    2026 
    2027     // set baseline to new ray from ref point (here endpoints[0]->node) to current candidate (here (*it)->point))
    2028     BaseRay = BLS[0];
    2029     if ((BTS != NULL) && (BTS->NormalVector.NormSquared() < MYEPSILON)) {
    2030       eLog() << Verbose(1) << "Triangle " << *BTS << " has zero normal vector!" << endl;
    2031       exit(255);
    2032     }
    2033 
    2034   }
    2035 
    2036   // remove all candidates from the list and then the list itself
    2037   class CandidateForTesselation *remover = NULL;
    2038   for (CandidateList::iterator it = OptCandidates->begin(); it != OptCandidates->end(); ++it) {
    2039     remover = *it;
    2040     delete(remover);
    2041   }
    2042   delete(OptCandidates);
    2043   Log() << Verbose(0) << "End of FindNextSuitableTriangle\n";
     2237  Log() << Verbose(0) << "Third Points are: " << endl;
     2238  for (TesselPointList::iterator it = CandidateLine.pointlist.begin(); it != CandidateLine.pointlist.end(); ++it) {
     2239    Log() << Verbose(0) << " " << *(*it) << endl;
     2240  }
     2241
     2242  return true;
     2243
     2244//  BoundaryLineSet *BaseRay = CandidateLine.BaseLine;
     2245//  for (CandidateList::iterator it = OptCandidates->begin(); it != OptCandidates->end(); ++it) {
     2246//    Log() << Verbose(0) << "Third point candidate is " << *(*it)->point
     2247//    << " with circumsphere's center at " << (*it)->OptCenter << "." << endl;
     2248//    Log() << Verbose(0) << "Baseline is " << *BaseRay << endl;
     2249//
     2250//    // check whether all edges of the new triangle still have space for one more triangle (i.e. TriangleCount <2)
     2251//    TesselPoint *PointCandidates[3];
     2252//    PointCandidates[0] = (*it)->point;
     2253//    PointCandidates[1] = BaseRay->endpoints[0]->node;
     2254//    PointCandidates[2] = BaseRay->endpoints[1]->node;
     2255//    int existentTrianglesCount = CheckPresenceOfTriangle(PointCandidates);
     2256//
     2257//    BTS = NULL;
     2258//    // check for present edges and whether we reach better candidates from them
     2259//    //if (HasOtherBaselineBetterCandidate(BaseRay, (*it)->point, ShortestAngle, RADIUS, LC) ) {
     2260//    if (0) {
     2261//      result = false;
     2262//      break;
     2263//    } else {
     2264//      // If there is no triangle, add it regularly.
     2265//      if (existentTrianglesCount == 0) {
     2266//        AddTesselationPoint((*it)->point, 0);
     2267//        AddTesselationPoint(BaseRay->endpoints[0]->node, 1);
     2268//        AddTesselationPoint(BaseRay->endpoints[1]->node, 2);
     2269//
     2270//        if (CheckLineCriteriaForDegeneratedTriangle((const BoundaryPointSet ** const )TPS)) {
     2271//          CandidateLine.point = (*it)->point;
     2272//          CandidateLine.OptCenter.CopyVector(&((*it)->OptCenter));
     2273//          CandidateLine.OtherOptCenter.CopyVector(&((*it)->OtherOptCenter));
     2274//          CandidateLine.ShortestAngle = ShortestAngle;
     2275//        } else {
     2276////          eLog() << Verbose(1) << "This triangle consisting of ";
     2277////          Log() << Verbose(0) << *(*it)->point << ", ";
     2278////          Log() << Verbose(0) << *BaseRay->endpoints[0]->node << " and ";
     2279////          Log() << Verbose(0) << *BaseRay->endpoints[1]->node << " ";
     2280////          Log() << Verbose(0) << "exists and is not added, as it 0x80000000006fc150(does not seem helpful!" << endl;
     2281//          result = false;
     2282//        }
     2283//      } else if ((existentTrianglesCount >= 1) && (existentTrianglesCount <= 3)) { // If there is a planar region within the structure, we need this triangle a second time.
     2284//          AddTesselationPoint((*it)->point, 0);
     2285//          AddTesselationPoint(BaseRay->endpoints[0]->node, 1);
     2286//          AddTesselationPoint(BaseRay->endpoints[1]->node, 2);
     2287//
     2288//          // We demand that at most one new degenerate line is created and that this line also already exists (which has to be the case due to existentTrianglesCount == 1)
     2289//          // i.e. at least one of the three lines must be present with TriangleCount <= 1
     2290//          if (CheckLineCriteriaForDegeneratedTriangle((const BoundaryPointSet ** const)TPS) || CandidateLine.BaseLine->skipped) {
     2291//            CandidateLine.point = (*it)->point;
     2292//            CandidateLine.OptCenter.CopyVector(&(*it)->OptCenter);
     2293//            CandidateLine.OtherOptCenter.CopyVector(&(*it)->OtherOptCenter);
     2294//            CandidateLine.ShortestAngle = ShortestAngle+2.*M_PI;
     2295//
     2296//          } else {
     2297////            eLog() << Verbose(1) << "This triangle consisting of " << *(*it)->point << ", " << *BaseRay->endpoints[0]->node << " and " << *BaseRay->endpoints[1]->node << " " << "exists and is not added, as it does not seem helpful!" << endl;
     2298//            result = false;
     2299//          }
     2300//      } else {
     2301////        Log() << Verbose(1) << "This triangle consisting of ";
     2302////        Log() << Verbose(0) << *(*it)->point << ", ";
     2303////        Log() << Verbose(0) << *BaseRay->endpoints[0]->node << " and ";
     2304////        Log() << Verbose(0) << *BaseRay->endpoints[1]->node << " ";
     2305////        Log() << Verbose(0) << "is invalid!" << endl;
     2306//        result = false;
     2307//      }
     2308//    }
     2309//
     2310//    // set baseline to new ray from ref point (here endpoints[0]->node) to current candidate (here (*it)->point))
     2311//    BaseRay = BLS[0];
     2312//    if ((BTS != NULL) && (BTS->NormalVector.NormSquared() < MYEPSILON)) {
     2313//      eLog() << Verbose(1) << "Triangle " << *BTS << " has zero normal vector!" << endl;
     2314//      exit(255);
     2315//    }
     2316//
     2317//  }
     2318//
     2319//  // remove all candidates from the list and then the list itself
     2320//  class CandidateForTesselation *remover = NULL;
     2321//  for (CandidateList::iterator it = OptCandidates->begin(); it != OptCandidates->end(); ++it) {
     2322//    remover = *it;
     2323//    delete(remover);
     2324//  }
     2325//  delete(OptCandidates);
    20442326  return result;
     2327};
     2328
     2329/** Adds the present line and candidate point from \a &CandidateLine to the Tesselation.
     2330 * \param CandidateLine triangle to add
     2331 * \NOTE we need the copy operator here as the original CandidateForTesselation is removed in AddTesselationLine()
     2332 */
     2333void Tesselation::AddCandidateTriangle(CandidateForTesselation CandidateLine)
     2334{
     2335        Info FunctionInfo(__func__);
     2336  Vector Center;
     2337  TesselPoint * const TurningPoint = CandidateLine.BaseLine->endpoints[0]->node;
     2338
     2339  // fill the set of neighbours
     2340  Center.CopyVector(CandidateLine.BaseLine->endpoints[1]->node->node);
     2341  Center.SubtractVector(TurningPoint->node);
     2342  set<TesselPoint*> SetOfNeighbours;
     2343  SetOfNeighbours.insert(CandidateLine.BaseLine->endpoints[1]->node);
     2344  for (TesselPointList::iterator Runner = CandidateLine.pointlist.begin(); Runner != CandidateLine.pointlist.end(); Runner++)
     2345    SetOfNeighbours.insert(*Runner);
     2346  TesselPointList *connectedClosestPoints = GetCircleOfSetOfPoints(&SetOfNeighbours, TurningPoint, &Center);
     2347
     2348  // go through all angle-sorted candidates (in degenerate n-nodes case we may have to add multiple triangles)
     2349  TesselPointList::iterator Runner = connectedClosestPoints->begin();
     2350  TesselPointList::iterator Sprinter = Runner;
     2351  Sprinter++;
     2352  while(Sprinter != connectedClosestPoints->end()) {
     2353    // add the points
     2354    AddTesselationPoint(TurningPoint, 0);
     2355    AddTesselationPoint((*Runner), 1);
     2356    AddTesselationPoint((*Sprinter), 2);
     2357
     2358
     2359    // add the lines
     2360    AddTesselationLine(TPS[0], TPS[1], 0);
     2361    AddTesselationLine(TPS[0], TPS[2], 1);
     2362    AddTesselationLine(TPS[1], TPS[2], 2);
     2363
     2364    // add the triangles
     2365    BTS = new class BoundaryTriangleSet(BLS, TrianglesOnBoundaryCount);
     2366    AddTesselationTriangle();
     2367    BTS->GetCenter(&Center);
     2368    Center.SubtractVector(&CandidateLine.OptCenter);
     2369    BTS->SphereCenter.CopyVector(&CandidateLine.OptCenter);
     2370    BTS->GetNormalVector(Center);
     2371
     2372    Log() << Verbose(0) << "--> New triangle with " << *BTS << " and normal vector " << BTS->NormalVector << "." << endl;
     2373    Runner = Sprinter;
     2374    Sprinter++;
     2375  }
     2376  delete(connectedClosestPoints);
    20452377};
    20462378
     
    20542386class BoundaryPointSet *Tesselation::IsConvexRectangle(class BoundaryLineSet *Base)
    20552387{
     2388        Info FunctionInfo(__func__);
    20562389  class BoundaryPointSet *Spot = NULL;
    20572390  class BoundaryLineSet *OtherBase;
     
    20652398  OtherBase = new class BoundaryLineSet(BPS,-1);
    20662399
    2067   Log() << Verbose(3) << "INFO: Current base line is " << *Base << "." << endl;
    2068   Log() << Verbose(3) << "INFO: Other base line is " << *OtherBase << "." << endl;
     2400  Log() << Verbose(1) << "INFO: Current base line is " << *Base << "." << endl;
     2401  Log() << Verbose(1) << "INFO: Other base line is " << *OtherBase << "." << endl;
    20692402
    20702403  // get the closest point on each line to the other line
     
    20862419  delete(ClosestPoint);
    20872420  if ((distance[0] * distance[1]) > 0)  { // have same sign?
    2088     Log() << Verbose(3) << "REJECT: Both SKPs have same sign: " << distance[0] << " and " << distance[1]  << ". " << *Base << "' rectangle is concave." << endl;
     2421    Log() << Verbose(1) << "REJECT: Both SKPs have same sign: " << distance[0] << " and " << distance[1]  << ". " << *Base << "' rectangle is concave." << endl;
    20892422    if (distance[0] < distance[1]) {
    20902423      Spot = Base->endpoints[0];
     
    20942427    return Spot;
    20952428  } else {  // different sign, i.e. we are in between
    2096     Log() << Verbose(3) << "ACCEPT: Rectangle of triangles of base line " << *Base << " is convex." << endl;
     2429    Log() << Verbose(0) << "ACCEPT: Rectangle of triangles of base line " << *Base << " is convex." << endl;
    20972430    return NULL;
    20982431  }
     
    21022435void Tesselation::PrintAllBoundaryPoints(ofstream *out) const
    21032436{
     2437        Info FunctionInfo(__func__);
    21042438  // print all lines
    2105   Log() << Verbose(1) << "Printing all boundary points for debugging:" << endl;
     2439  Log() << Verbose(0) << "Printing all boundary points for debugging:" << endl;
    21062440  for (PointMap::const_iterator PointRunner = PointsOnBoundary.begin();PointRunner != PointsOnBoundary.end(); PointRunner++)
    2107     Log() << Verbose(2) << *(PointRunner->second) << endl;
     2441    Log() << Verbose(0) << *(PointRunner->second) << endl;
    21082442};
    21092443
    21102444void Tesselation::PrintAllBoundaryLines(ofstream *out) const
    21112445{
     2446        Info FunctionInfo(__func__);
    21122447  // print all lines
    2113   Log() << Verbose(1) << "Printing all boundary lines for debugging:" << endl;
     2448  Log() << Verbose(0) << "Printing all boundary lines for debugging:" << endl;
    21142449  for (LineMap::const_iterator LineRunner = LinesOnBoundary.begin(); LineRunner != LinesOnBoundary.end(); LineRunner++)
    2115     Log() << Verbose(2) << *(LineRunner->second) << endl;
     2450    Log() << Verbose(0) << *(LineRunner->second) << endl;
    21162451};
    21172452
    21182453void Tesselation::PrintAllBoundaryTriangles(ofstream *out) const
    21192454{
     2455        Info FunctionInfo(__func__);
    21202456  // print all triangles
    2121   Log() << Verbose(1) << "Printing all boundary triangles for debugging:" << endl;
     2457  Log() << Verbose(0) << "Printing all boundary triangles for debugging:" << endl;
    21222458  for (TriangleMap::const_iterator TriangleRunner = TrianglesOnBoundary.begin(); TriangleRunner != TrianglesOnBoundary.end(); TriangleRunner++)
    2123     Log() << Verbose(2) << *(TriangleRunner->second) << endl;
     2459    Log() << Verbose(0) << *(TriangleRunner->second) << endl;
    21242460};
    21252461
     
    21312467double Tesselation::PickFarthestofTwoBaselines(class BoundaryLineSet *Base)
    21322468{
     2469        Info FunctionInfo(__func__);
    21332470  class BoundaryLineSet *OtherBase;
    21342471  Vector *ClosestPoint[2];
     
    21422479  OtherBase = new class BoundaryLineSet(BPS,-1);
    21432480
    2144   Log() << Verbose(3) << "INFO: Current base line is " << *Base << "." << endl;
    2145   Log() << Verbose(3) << "INFO: Other base line is " << *OtherBase << "." << endl;
     2481  Log() << Verbose(0) << "INFO: Current base line is " << *Base << "." << endl;
     2482  Log() << Verbose(0) << "INFO: Other base line is " << *OtherBase << "." << endl;
    21462483
    21472484  // get the closest point on each line to the other line
     
    21632500
    21642501  if (Distance.NormSquared() < MYEPSILON) { // check for intersection
    2165     Log() << Verbose(3) << "REJECT: Both lines have an intersection: Nothing to do." << endl;
     2502    Log() << Verbose(0) << "REJECT: Both lines have an intersection: Nothing to do." << endl;
    21662503    return false;
    21672504  } else { // check for sign against BaseLineNormal
     
    21732510    }
    21742511    for (TriangleMap::iterator runner = Base->triangles.begin(); runner != Base->triangles.end(); runner++) {
    2175       Log() << Verbose(4) << "INFO: Adding NormalVector " << runner->second->NormalVector << " of triangle " << *(runner->second) << "." << endl;
     2512      Log() << Verbose(1) << "INFO: Adding NormalVector " << runner->second->NormalVector << " of triangle " << *(runner->second) << "." << endl;
    21762513      BaseLineNormal.AddVector(&(runner->second->NormalVector));
    21772514    }
     
    21792516
    21802517    if (Distance.ScalarProduct(&BaseLineNormal) > MYEPSILON) { // Distance points outwards, hence OtherBase higher than Base -> flip
    2181       Log() << Verbose(2) << "ACCEPT: Other base line would be higher: Flipping baseline." << endl;
     2518      Log() << Verbose(0) << "ACCEPT: Other base line would be higher: Flipping baseline." << endl;
    21822519      // calculate volume summand as a general tetraeder
    21832520      return volume;
    21842521    } else {  // Base higher than OtherBase -> do nothing
    2185       Log() << Verbose(2) << "REJECT: Base line is higher: Nothing to do." << endl;
     2522      Log() << Verbose(0) << "REJECT: Base line is higher: Nothing to do." << endl;
    21862523      return 0.;
    21872524    }
     
    21982535class BoundaryLineSet * Tesselation::FlipBaseline(class BoundaryLineSet *Base)
    21992536{
     2537        Info FunctionInfo(__func__);
    22002538  class BoundaryLineSet *OldLines[4], *NewLine;
    22012539  class BoundaryPointSet *OldPoints[2];
     
    22042542  int i,m;
    22052543
    2206   Log() << Verbose(1) << "Begin of FlipBaseline" << endl;
    2207 
    22082544  // calculate NormalVector for later use
    22092545  BaseLineNormal.Zero();
     
    22132549  }
    22142550  for (TriangleMap::iterator runner = Base->triangles.begin(); runner != Base->triangles.end(); runner++) {
    2215     Log() << Verbose(4) << "INFO: Adding NormalVector " << runner->second->NormalVector << " of triangle " << *(runner->second) << "." << endl;
     2551    Log() << Verbose(1) << "INFO: Adding NormalVector " << runner->second->NormalVector << " of triangle " << *(runner->second) << "." << endl;
    22162552    BaseLineNormal.AddVector(&(runner->second->NormalVector));
    22172553  }
     
    22262562  i=0;
    22272563  m=0;
    2228   Log() << Verbose(3) << "The four old lines are: ";
     2564  Log() << Verbose(0) << "The four old lines are: ";
    22292565  for(TriangleMap::iterator runner = Base->triangles.begin(); runner != Base->triangles.end(); runner++)
    22302566    for (int j=0;j<3;j++) // all of their endpoints and baselines
     
    22342570      }
    22352571  Log() << Verbose(0) << endl;
    2236   Log() << Verbose(3) << "The two old points are: ";
     2572  Log() << Verbose(0) << "The two old points are: ";
    22372573  for(TriangleMap::iterator runner = Base->triangles.begin(); runner != Base->triangles.end(); runner++)
    22382574    for (int j=0;j<3;j++) // all of their endpoints and baselines
     
    22602596
    22612597  // remove triangles and baseline removes itself
    2262   Log() << Verbose(3) << "INFO: Deleting baseline " << *Base << " from global list." << endl;
     2598  Log() << Verbose(0) << "INFO: Deleting baseline " << *Base << " from global list." << endl;
    22632599  OldBaseLineNr = Base->Nr;
    22642600  m=0;
    22652601  for(TriangleMap::iterator runner = Base->triangles.begin(); runner != Base->triangles.end(); runner++) {
    2266     Log() << Verbose(3) << "INFO: Deleting triangle " << *(runner->second) << "." << endl;
     2602    Log() << Verbose(0) << "INFO: Deleting triangle " << *(runner->second) << "." << endl;
    22672603    OldTriangleNrs[m++] = runner->second->Nr;
    22682604    RemoveTesselationTriangle(runner->second);
     
    22742610  NewLine = new class BoundaryLineSet(BPS, OldBaseLineNr);
    22752611  LinesOnBoundary.insert(LinePair(OldBaseLineNr, NewLine)); // no need for check for unique insertion as NewLine is definitely a new one
    2276   Log() << Verbose(3) << "INFO: Created new baseline " << *NewLine << "." << endl;
     2612  Log() << Verbose(0) << "INFO: Created new baseline " << *NewLine << "." << endl;
    22772613
    22782614  // construct new triangles with flipped baseline
     
    22892625    BTS->GetNormalVector(BaseLineNormal);
    22902626    AddTesselationTriangle(OldTriangleNrs[0]);
    2291     Log() << Verbose(3) << "INFO: Created new triangle " << *BTS << "." << endl;
     2627    Log() << Verbose(0) << "INFO: Created new triangle " << *BTS << "." << endl;
    22922628
    22932629    BLS[0] = (i==2 ? OldLines[3] : OldLines[2]);
     
    22972633    BTS->GetNormalVector(BaseLineNormal);
    22982634    AddTesselationTriangle(OldTriangleNrs[1]);
    2299     Log() << Verbose(3) << "INFO: Created new triangle " << *BTS << "." << endl;
     2635    Log() << Verbose(0) << "INFO: Created new triangle " << *BTS << "." << endl;
    23002636  } else {
    2301     Log() << Verbose(1) << "The four old lines do not connect, something's utterly wrong here!" << endl;
     2637    eLog() << Verbose(0) << "The four old lines do not connect, something's utterly wrong here!" << endl;
    23022638    return NULL;
    23032639  }
    23042640
    2305   Log() << Verbose(1) << "End of FlipBaseline" << endl;
    23062641  return NewLine;
    23072642};
     
    23182653void Tesselation::FindSecondPointForTesselation(TesselPoint* a, Vector Oben, TesselPoint*& OptCandidate, double Storage[3], double RADIUS, const LinkedCell *LC)
    23192654{
    2320   Log() << Verbose(2) << "Begin of FindSecondPointForTesselation" << endl;
     2655        Info FunctionInfo(__func__);
    23212656  Vector AngleCheck;
    23222657  class TesselPoint* Candidate = NULL;
     
    23392674    Nupper[i] = ((N[i]+1) < LC->N[i]) ? N[i]+1 : LC->N[i]-1;
    23402675  }
    2341   Log() << Verbose(3) << "LC Intervals from [" << N[0] << "<->" << LC->N[0] << ", " << N[1] << "<->" << LC->N[1] << ", " << N[2] << "<->" << LC->N[2] << "] :"
     2676  Log() << Verbose(0) << "LC Intervals from [" << N[0] << "<->" << LC->N[0] << ", " << N[1] << "<->" << LC->N[1] << ", " << N[2] << "<->" << LC->N[2] << "] :"
    23422677    << " [" << Nlower[0] << "," << Nupper[0] << "], " << " [" << Nlower[1] << "," << Nupper[1] << "], " << " [" << Nlower[2] << "," << Nupper[2] << "], " << endl;
    23432678
     
    23462681      for (LC->n[2] = Nlower[2]; LC->n[2] <= Nupper[2]; LC->n[2]++) {
    23472682        const LinkedNodes *List = LC->GetCurrentCell();
    2348         //Log() << Verbose(2) << "Current cell is " << LC->n[0] << ", " << LC->n[1] << ", " << LC->n[2] << " with No. " << LC->index << "." << endl;
     2683        //Log() << Verbose(1) << "Current cell is " << LC->n[0] << ", " << LC->n[1] << ", " << LC->n[2] << " with No. " << LC->index << "." << endl;
    23492684        if (List != NULL) {
    23502685          for (LinkedNodes::const_iterator Runner = List->begin(); Runner != List->end(); Runner++) {
     
    23772712                angle = AngleCheck.Angle(&Oben);
    23782713                if (angle < Storage[0]) {
    2379                   //Log() << Verbose(3) << "Old values of Storage: %lf %lf \n", Storage[0], Storage[1]);
    2380                   Log() << Verbose(3) << "Current candidate is " << *Candidate << ": Is a better candidate with distance " << norm << " and angle " << angle << " to oben " << Oben << ".\n";
     2714                  //Log() << Verbose(1) << "Old values of Storage: %lf %lf \n", Storage[0], Storage[1]);
     2715                  Log() << Verbose(1) << "Current candidate is " << *Candidate << ": Is a better candidate with distance " << norm << " and angle " << angle << " to oben " << Oben << ".\n";
    23812716                  OptCandidate = Candidate;
    23822717                  Storage[0] = angle;
    2383                   //Log() << Verbose(3) << "Changing something in Storage: %lf %lf. \n", Storage[0], Storage[2]);
     2718                  //Log() << Verbose(1) << "Changing something in Storage: %lf %lf. \n", Storage[0], Storage[2]);
    23842719                } else {
    2385                   //Log() << Verbose(3) << "Current candidate is " << *Candidate << ": Looses with angle " << angle << " to a better candidate " << *OptCandidate << endl;
     2720                  //Log() << Verbose(1) << "Current candidate is " << *Candidate << ": Looses with angle " << angle << " to a better candidate " << *OptCandidate << endl;
    23862721                }
    23872722              } else {
    2388                 //Log() << Verbose(3) << "Current candidate is " << *Candidate << ": Refused due to Radius " << norm << endl;
     2723                //Log() << Verbose(1) << "Current candidate is " << *Candidate << ": Refused due to Radius " << norm << endl;
    23892724              }
    23902725            } else {
    2391               //Log() << Verbose(3) << "Current candidate is " << *Candidate << ": Candidate is equal to first endpoint." << *a << "." << endl;
     2726              //Log() << Verbose(1) << "Current candidate is " << *Candidate << ": Candidate is equal to first endpoint." << *a << "." << endl;
    23922727            }
    23932728          }
    23942729        } else {
    2395           Log() << Verbose(3) << "Linked cell list is empty." << endl;
     2730          Log() << Verbose(0) << "Linked cell list is empty." << endl;
    23962731        }
    23972732      }
    2398   Log() << Verbose(2) << "End of FindSecondPointForTesselation" << endl;
    23992733};
    24002734
     
    24252759 * @param SearchDirection general direction where to search for the next point, relative to center of BaseLine
    24262760 * @param OldSphereCenter center of sphere for base triangle, relative to center of BaseLine, giving null angle for the parameter circle
    2427  * @param BaseLine BoundaryLineSet with the current base line
     2761 * @param CandidateLine CandidateForTesselation with the current base line and list of candidates and ShortestAngle
    24282762 * @param ThirdNode third point to avoid in search
    2429  * @param candidates list of equally good candidates to return
    2430  * @param ShortestAngle the current path length on this circle band for the current OptCandidate
    24312763 * @param RADIUS radius of sphere
    24322764 * @param *LC LinkedCell structure with neighbouring points
    24332765 */
    2434 void Tesselation::FindThirdPointForTesselation(Vector &NormalVector, Vector &SearchDirection, Vector &OldSphereCenter, class BoundaryLineSet *BaseLine, const class TesselPoint  * const ThirdNode, CandidateList* &candidates, double *ShortestAngle, const double RADIUS, const LinkedCell *LC) const
    2435 {
     2766void Tesselation::FindThirdPointForTesselation(Vector &NormalVector, Vector &SearchDirection, Vector &OldSphereCenter, CandidateForTesselation &CandidateLine, const class TesselPoint  * const ThirdNode, const double RADIUS, const LinkedCell *LC) const
     2767{
     2768        Info FunctionInfo(__func__);
    24362769  Vector CircleCenter;  // center of the circle, i.e. of the band of sphere's centers
    24372770  Vector CirclePlaneNormal; // normal vector defining the plane this circle lives in
     
    24412774  Vector NewNormalVector;   // normal vector of the Candidate's triangle
    24422775  Vector helper, OptCandidateCenter, OtherOptCandidateCenter;
     2776  Vector RelativeOldSphereCenter;
     2777  Vector NewPlaneCenter;
    24432778  double CircleRadius; // radius of this circle
    24442779  double radius;
     2780  double otherradius;
    24452781  double alpha, Otheralpha; // angles (i.e. parameter for the circle).
    24462782  int N[NDIM], Nlower[NDIM], Nupper[NDIM];
    24472783  TesselPoint *Candidate = NULL;
    2448   CandidateForTesselation *optCandidate = NULL;
    2449 
    2450   Log() << Verbose(1) << "Begin of FindThirdPointForTesselation" << endl;
    2451 
    2452   Log() << Verbose(2) << "INFO: NormalVector of BaseTriangle is " << NormalVector << "." << endl;
     2784
     2785  Log() << Verbose(1) << "INFO: NormalVector of BaseTriangle is " << NormalVector << "." << endl;
    24532786
    24542787  // construct center of circle
    2455   CircleCenter.CopyVector(BaseLine->endpoints[0]->node->node);
    2456   CircleCenter.AddVector(BaseLine->endpoints[1]->node->node);
     2788  CircleCenter.CopyVector(CandidateLine.BaseLine->endpoints[0]->node->node);
     2789  CircleCenter.AddVector(CandidateLine.BaseLine->endpoints[1]->node->node);
    24572790  CircleCenter.Scale(0.5);
    24582791
    24592792  // construct normal vector of circle
    2460   CirclePlaneNormal.CopyVector(BaseLine->endpoints[0]->node->node);
    2461   CirclePlaneNormal.SubtractVector(BaseLine->endpoints[1]->node->node);
     2793  CirclePlaneNormal.CopyVector(CandidateLine.BaseLine->endpoints[0]->node->node);
     2794  CirclePlaneNormal.SubtractVector(CandidateLine.BaseLine->endpoints[1]->node->node);
     2795
     2796  RelativeOldSphereCenter.CopyVector(&OldSphereCenter);
     2797  RelativeOldSphereCenter.SubtractVector(&CircleCenter);
    24622798
    24632799  // calculate squared radius TesselPoint *ThirdNode,f circle
    2464   radius = CirclePlaneNormal.ScalarProduct(&CirclePlaneNormal);
    2465   if (radius/4. < RADIUS*RADIUS) {
    2466     CircleRadius = RADIUS*RADIUS - radius/4.;
     2800  radius = CirclePlaneNormal.NormSquared()/4.;
     2801  if (radius < RADIUS*RADIUS) {
     2802    CircleRadius = RADIUS*RADIUS - radius;
    24672803    CirclePlaneNormal.Normalize();
    2468     //Log() << Verbose(2) << "INFO: CircleCenter is at " << CircleCenter << ", CirclePlaneNormal is " << CirclePlaneNormal << " with circle radius " << sqrt(CircleRadius) << "." << endl;
     2804    Log() << Verbose(1) << "INFO: CircleCenter is at " << CircleCenter << ", CirclePlaneNormal is " << CirclePlaneNormal << " with circle radius " << sqrt(CircleRadius) << "." << endl;
    24692805
    24702806    // test whether old center is on the band's plane
    2471     if (fabs(OldSphereCenter.ScalarProduct(&CirclePlaneNormal)) > HULLEPSILON) {
    2472       eLog() << Verbose(1) << "Something's very wrong here: OldSphereCenter is not on the band's plane as desired by " << fabs(OldSphereCenter.ScalarProduct(&CirclePlaneNormal)) << "!" << endl;
    2473       OldSphereCenter.ProjectOntoPlane(&CirclePlaneNormal);
    2474     }
    2475     radius = OldSphereCenter.ScalarProduct(&OldSphereCenter);
     2807    if (fabs(RelativeOldSphereCenter.ScalarProduct(&CirclePlaneNormal)) > HULLEPSILON) {
     2808      eLog() << Verbose(1) << "Something's very wrong here: RelativeOldSphereCenter is not on the band's plane as desired by " << fabs(RelativeOldSphereCenter.ScalarProduct(&CirclePlaneNormal)) << "!" << endl;
     2809      RelativeOldSphereCenter.ProjectOntoPlane(&CirclePlaneNormal);
     2810    }
     2811    radius = RelativeOldSphereCenter.NormSquared();
    24762812    if (fabs(radius - CircleRadius) < HULLEPSILON) {
    2477       //Log() << Verbose(2) << "INFO: OldSphereCenter is at " << OldSphereCenter << "." << endl;
     2813      Log() << Verbose(1) << "INFO: RelativeOldSphereCenter is at " << RelativeOldSphereCenter << "." << endl;
    24782814
    24792815      // check SearchDirection
    2480       //Log() << Verbose(2) << "INFO: SearchDirection is " << SearchDirection << "." << endl;
    2481       if (fabs(OldSphereCenter.ScalarProduct(&SearchDirection)) > HULLEPSILON) {  // rotated the wrong way!
     2816      Log() << Verbose(1) << "INFO: SearchDirection is " << SearchDirection << "." << endl;
     2817      if (fabs(RelativeOldSphereCenter.ScalarProduct(&SearchDirection)) > HULLEPSILON) {  // rotated the wrong way!
    24822818        eLog() << Verbose(1) << "SearchDirection and RelativeOldSphereCenter are not orthogonal!" << endl;
    24832819      }
     
    24872823        for(int i=0;i<NDIM;i++) // store indices of this cell
    24882824        N[i] = LC->n[i];
    2489         //Log() << Verbose(2) << "INFO: Center cell is " << N[0] << ", " << N[1] << ", " << N[2] << " with No. " << LC->index << "." << endl;
     2825        //Log() << Verbose(1) << "INFO: Center cell is " << N[0] << ", " << N[1] << ", " << N[2] << " with No. " << LC->index << "." << endl;
    24902826      } else {
    24912827        eLog() << Verbose(1) << "Vector " << CircleCenter << " is outside of LinkedCell's bounding box." << endl;
     
    24932829      }
    24942830      // then go through the current and all neighbouring cells and check the contained points for possible candidates
    2495       //Log() << Verbose(2) << "LC Intervals:";
     2831      //Log() << Verbose(1) << "LC Intervals:";
    24962832      for (int i=0;i<NDIM;i++) {
    24972833        Nlower[i] = ((N[i]-1) >= 0) ? N[i]-1 : 0;
     
    25042840          for (LC->n[2] = Nlower[2]; LC->n[2] <= Nupper[2]; LC->n[2]++) {
    25052841            const LinkedNodes *List = LC->GetCurrentCell();
    2506             //Log() << Verbose(2) << "Current cell is " << LC->n[0] << ", " << LC->n[1] << ", " << LC->n[2] << " with No. " << LC->index << "." << endl;
     2842            //Log() << Verbose(1) << "Current cell is " << LC->n[0] << ", " << LC->n[1] << ", " << LC->n[2] << " with No. " << LC->index << "." << endl;
    25072843            if (List != NULL) {
    25082844              for (LinkedNodes::const_iterator Runner = List->begin(); Runner != List->end(); Runner++) {
     
    25102846
    25112847                // check for three unique points
    2512                 //Log() << Verbose(2) << "INFO: Current Candidate is " << *Candidate << " at " << Candidate->node << "." << endl;
    2513                 if ((Candidate != BaseLine->endpoints[0]->node) && (Candidate != BaseLine->endpoints[1]->node) ){
    2514 
    2515                   // construct both new centers
    2516                   GetCenterofCircumcircle(&NewSphereCenter, *BaseLine->endpoints[0]->node->node, *BaseLine->endpoints[1]->node->node, *Candidate->node);
    2517                   OtherNewSphereCenter.CopyVector(&NewSphereCenter);
    2518 
    2519                   if ((NewNormalVector.MakeNormalVector(BaseLine->endpoints[0]->node->node, BaseLine->endpoints[1]->node->node, Candidate->node))
    2520                   && (fabs(NewNormalVector.ScalarProduct(&NewNormalVector)) > HULLEPSILON)
     2848                Log() << Verbose(2) << "INFO: Current Candidate is " << *Candidate << " for BaseLine " << *CandidateLine.BaseLine << " with OldSphereCenter " << OldSphereCenter << "." << endl;
     2849                if ((Candidate != CandidateLine.BaseLine->endpoints[0]->node) && (Candidate != CandidateLine.BaseLine->endpoints[1]->node) ){
     2850
     2851                  // find center on the plane
     2852                  GetCenterofCircumcircle(&NewPlaneCenter, *CandidateLine.BaseLine->endpoints[0]->node->node, *CandidateLine.BaseLine->endpoints[1]->node->node, *Candidate->node);
     2853                  Log() << Verbose(1) << "INFO: NewPlaneCenter is " << NewPlaneCenter << "." << endl;
     2854
     2855                  if (NewNormalVector.MakeNormalVector(CandidateLine.BaseLine->endpoints[0]->node->node, CandidateLine.BaseLine->endpoints[1]->node->node, Candidate->node)
     2856                  && (fabs(NewNormalVector.NormSquared()) > HULLEPSILON)
    25212857                  ) {
    2522                     helper.CopyVector(&NewNormalVector);
    2523                     //Log() << Verbose(2) << "INFO: NewNormalVector is " << NewNormalVector << "." << endl;
    2524                     radius = BaseLine->endpoints[0]->node->node->DistanceSquared(&NewSphereCenter);
     2858                    Log() << Verbose(1) << "INFO: NewNormalVector is " << NewNormalVector << "." << endl;
     2859                    radius = CandidateLine.BaseLine->endpoints[0]->node->node->DistanceSquared(&NewPlaneCenter);
     2860                    Log() << Verbose(1) << "INFO: CircleCenter is at " << CircleCenter << ", CirclePlaneNormal is " << CirclePlaneNormal << " with circle radius " << sqrt(CircleRadius) << "." << endl;
     2861                    Log() << Verbose(1) << "INFO: SearchDirection is " << SearchDirection << "." << endl;
     2862                    Log() << Verbose(1) << "INFO: Radius of CircumCenterCircle is " << radius << "." << endl;
    25252863                    if (radius < RADIUS*RADIUS) {
     2864                      otherradius = CandidateLine.BaseLine->endpoints[1]->node->node->DistanceSquared(&NewPlaneCenter);
     2865                      if (fabs(radius - otherradius) > HULLEPSILON) {
     2866                        eLog() << Verbose(1) << "Distance to center of circumcircle is not the same from each corner of the triangle: " << fabs(radius-otherradius) << endl;
     2867                      }
     2868                      // construct both new centers
     2869                      NewSphereCenter.CopyVector(&NewPlaneCenter);
     2870                      OtherNewSphereCenter.CopyVector(&NewPlaneCenter);
     2871                      helper.CopyVector(&NewNormalVector);
    25262872                      helper.Scale(sqrt(RADIUS*RADIUS - radius));
    2527                       //Log() << Verbose(2) << "INFO: Distance of NewCircleCenter to NewSphereCenter is " << helper.Norm() << " with sphere radius " << RADIUS << "." << endl;
     2873                      Log() << Verbose(2) << "INFO: Distance of NewPlaneCenter " << NewPlaneCenter << " to either NewSphereCenter is " << helper.Norm() << " of vector " << helper << " with sphere radius " << RADIUS << "." << endl;
    25282874                      NewSphereCenter.AddVector(&helper);
    2529                       NewSphereCenter.SubtractVector(&CircleCenter);
    2530                       //Log() << Verbose(2) << "INFO: NewSphereCenter is at " << NewSphereCenter << "." << endl;
    2531 
     2875                      Log() << Verbose(2) << "INFO: NewSphereCenter is at " << NewSphereCenter << "." << endl;
    25322876                      // OtherNewSphereCenter is created by the same vector just in the other direction
    25332877                      helper.Scale(-1.);
    25342878                      OtherNewSphereCenter.AddVector(&helper);
    2535                       OtherNewSphereCenter.SubtractVector(&CircleCenter);
    2536                       //Log() << Verbose(2) << "INFO: OtherNewSphereCenter is at " << OtherNewSphereCenter << "." << endl;
     2879                      Log() << Verbose(2) << "INFO: OtherNewSphereCenter is at " << OtherNewSphereCenter << "." << endl;
    25372880
    25382881                      alpha = GetPathLengthonCircumCircle(CircleCenter, CirclePlaneNormal, CircleRadius, NewSphereCenter, OldSphereCenter, NormalVector, SearchDirection);
    25392882                      Otheralpha = GetPathLengthonCircumCircle(CircleCenter, CirclePlaneNormal, CircleRadius, OtherNewSphereCenter, OldSphereCenter, NormalVector, SearchDirection);
    25402883                      alpha = min(alpha, Otheralpha);
     2884
    25412885                      // if there is a better candidate, drop the current list and add the new candidate
    25422886                      // otherwise ignore the new candidate and keep the list
    2543                       if (*ShortestAngle > (alpha - HULLEPSILON)) {
    2544                         optCandidate = new CandidateForTesselation(Candidate, BaseLine, OptCandidateCenter, OtherOptCandidateCenter);
     2887                      if (CandidateLine.ShortestAngle > (alpha - HULLEPSILON)) {
    25452888                        if (fabs(alpha - Otheralpha) > MYEPSILON) {
    2546                           optCandidate->OptCenter.CopyVector(&NewSphereCenter);
    2547                           optCandidate->OtherOptCenter.CopyVector(&OtherNewSphereCenter);
     2889                          CandidateLine.OptCenter.CopyVector(&NewSphereCenter);
     2890                          CandidateLine.OtherOptCenter.CopyVector(&OtherNewSphereCenter);
    25482891                        } else {
    2549                           optCandidate->OptCenter.CopyVector(&OtherNewSphereCenter);
    2550                           optCandidate->OtherOptCenter.CopyVector(&NewSphereCenter);
     2892                          CandidateLine.OptCenter.CopyVector(&OtherNewSphereCenter);
     2893                          CandidateLine.OtherOptCenter.CopyVector(&NewSphereCenter);
    25512894                        }
    25522895                        // if there is an equal candidate, add it to the list without clearing the list
    2553                         if ((*ShortestAngle - HULLEPSILON) < alpha) {
    2554                           candidates->push_back(optCandidate);
    2555                           Log() << Verbose(2) << "ACCEPT: We have found an equally good candidate: " << *(optCandidate->point) << " with "
    2556                             << alpha << " and circumsphere's center at " << optCandidate->OptCenter << "." << endl;
     2896                        if ((CandidateLine.ShortestAngle - HULLEPSILON) < alpha) {
     2897                          CandidateLine.pointlist.push_back(Candidate);
     2898                          Log() << Verbose(0) << "ACCEPT: We have found an equally good candidate: " << *(Candidate) << " with "
     2899                            << alpha << " and circumsphere's center at " << CandidateLine.OptCenter << "." << endl;
    25572900                        } else {
    25582901                          // remove all candidates from the list and then the list itself
    2559                           class CandidateForTesselation *remover = NULL;
    2560                           for (CandidateList::iterator it = candidates->begin(); it != candidates->end(); ++it) {
    2561                             remover = *it;
    2562                             delete(remover);
    2563                           }
    2564                           candidates->clear();
    2565                           candidates->push_back(optCandidate);
    2566                           Log() << Verbose(2) << "ACCEPT: We have found a better candidate: " << *(optCandidate->point) << " with "
    2567                             << alpha << " and circumsphere's center at " << optCandidate->OptCenter << "." << endl;
     2902                          CandidateLine.pointlist.clear();
     2903                          CandidateLine.pointlist.push_back(Candidate);
     2904                          Log() << Verbose(0) << "ACCEPT: We have found a better candidate: " << *(Candidate) << " with "
     2905                            << alpha << " and circumsphere's center at " << CandidateLine.OptCenter << "." << endl;
    25682906                        }
    2569                         *ShortestAngle = alpha;
    2570                         //Log() << Verbose(2) << "INFO: There are " << candidates->size() << " candidates in the list now." << endl;
     2907                        CandidateLine.ShortestAngle = alpha;
     2908                        Log() << Verbose(0) << "INFO: There are " << CandidateLine.pointlist.size() << " candidates in the list now." << endl;
    25712909                      } else {
    2572                         if ((optCandidate != NULL) && (optCandidate->point != NULL)) {
    2573                           //Log() << Verbose(2) << "REJECT: Old candidate " << *(optCandidate->point) << " with " << *ShortestAngle << " is better than new one " << *Candidate << " with " << alpha << " ." << endl;
     2910                        if ((Candidate != NULL) && (CandidateLine.pointlist.begin() != CandidateLine.pointlist.end())) {
     2911                          Log() << Verbose(1) << "REJECT: Old candidate " << *(Candidate) << " with " << CandidateLine.ShortestAngle << " is better than new one " << *Candidate << " with " << alpha << " ." << endl;
    25742912                        } else {
    2575                           //Log() << Verbose(2) << "REJECT: Candidate " << *Candidate << " with " << alpha << " was rejected." << endl;
     2913                          Log() << Verbose(1) << "REJECT: Candidate " << *Candidate << " with " << alpha << " was rejected." << endl;
    25762914                        }
    25772915                      }
    2578 
    25792916                    } else {
    2580                       //Log() << Verbose(2) << "REJECT: NewSphereCenter " << NewSphereCenter << " for " << *Candidate << " is too far away: " << radius << "." << endl;
     2917                      Log() << Verbose(1) << "REJECT: NewSphereCenter " << NewSphereCenter << " for " << *Candidate << " is too far away: " << radius << "." << endl;
    25812918                    }
    25822919                  } else {
    2583                     //Log() << Verbose(2) << "REJECT: Three points from " << *BaseLine << " and Candidate " << *Candidate << " are linear-dependent." << endl;
     2920                    Log() << Verbose(1) << "REJECT: Three points from " << *CandidateLine.BaseLine << " and Candidate " << *Candidate << " are linear-dependent." << endl;
    25842921                  }
    25852922                } else {
    25862923                  if (ThirdNode != NULL) {
    2587                     //Log() << Verbose(2) << "REJECT: Base triangle " << *BaseLine << " and " << *ThirdNode << " contains Candidate " << *Candidate << "." << endl;
     2924                    Log() << Verbose(1) << "REJECT: Base triangle " << *CandidateLine.BaseLine << " and " << *ThirdNode << " contains Candidate " << *Candidate << "." << endl;
    25882925                  } else {
    2589                     //Log() << Verbose(2) << "REJECT: Base triangle " << *BaseLine << " contains Candidate " << *Candidate << "." << endl;
     2926                    Log() << Verbose(1) << "REJECT: Base triangle " << *CandidateLine.BaseLine << " contains Candidate " << *Candidate << "." << endl;
    25902927                  }
    25912928                }
     
    25982935  } else {
    25992936    if (ThirdNode != NULL)
    2600       Log() << Verbose(2) << "Circumcircle for base line " << *BaseLine << " and third node " << *ThirdNode << " is too big!" << endl;
     2937      Log() << Verbose(1) << "Circumcircle for base line " << *CandidateLine.BaseLine << " and third node " << *ThirdNode << " is too big!" << endl;
    26012938    else
    2602       Log() << Verbose(2) << "Circumcircle for base line " << *BaseLine << " is too big!" << endl;
    2603   }
    2604 
    2605   //Log() << Verbose(2) << "INFO: Sorting candidate list ..." << endl;
    2606   if (candidates->size() > 1) {
    2607     candidates->unique();
    2608     candidates->sort(SortCandidates);
    2609   }
    2610 
    2611   Log() << Verbose(1) << "End of FindThirdPointForTesselation" << endl;
     2939      Log() << Verbose(1) << "Circumcircle for base line " << *CandidateLine.BaseLine << " is too big!" << endl;
     2940  }
     2941
     2942  Log() << Verbose(1) << "INFO: Sorting candidate list ..." << endl;
     2943  if (CandidateLine.pointlist.size() > 1) {
     2944    CandidateLine.pointlist.unique();
     2945    CandidateLine.pointlist.sort(); //SortCandidates);
     2946  }
    26122947};
    26132948
     
    26192954class BoundaryPointSet *Tesselation::GetCommonEndpoint(const BoundaryLineSet * line1, const BoundaryLineSet * line2) const
    26202955{
     2956        Info FunctionInfo(__func__);
    26212957  const BoundaryLineSet * lines[2] = { line1, line2 };
    26222958  class BoundaryPointSet *node = NULL;
     
    26322968          { // if insertion fails, we have common endpoint
    26332969            node = OrderTest.first->second;
    2634             Log() << Verbose(5) << "Common endpoint of lines " << *line1
     2970            Log() << Verbose(1) << "Common endpoint of lines " << *line1
    26352971                << " and " << *line2 << " is: " << *node << "." << endl;
    26362972            j = 2;
     
    26492985list<BoundaryTriangleSet*> * Tesselation::FindClosestTrianglesToPoint(const Vector *x, const LinkedCell* LC) const
    26502986{
     2987        Info FunctionInfo(__func__);
    26512988  TesselPoint *trianglePoints[3];
    26522989  TesselPoint *SecondPoint = NULL;
     
    26542991
    26552992  if (LinesOnBoundary.empty()) {
    2656     Log() << Verbose(0) << "Error: There is no tesselation structure to compare the point with, please create one first.";
     2993    eLog() << Verbose(1) << "Error: There is no tesselation structure to compare the point with, please create one first.";
    26572994    return NULL;
    26582995  }
     
    26622999  // check whether closest point is "too close" :), then it's inside
    26633000  if (trianglePoints[0] == NULL) {
    2664     Log() << Verbose(2) << "Is the only point, no one else is closeby." << endl;
     3001    Log() << Verbose(0) << "Is the only point, no one else is closeby." << endl;
    26653002    return NULL;
    26663003  }
    26673004  if (trianglePoints[0]->node->DistanceSquared(x) < MYEPSILON) {
    2668     Log() << Verbose(3) << "Point is right on a tesselation point, no nearest triangle." << endl;
     3005    Log() << Verbose(1) << "Point is right on a tesselation point, no nearest triangle." << endl;
    26693006    PointMap::const_iterator PointRunner = PointsOnBoundary.find(trianglePoints[0]->nr);
    26703007    triangles = new list<BoundaryTriangleSet*>;
     
    26903027    }
    26913028  } else {
    2692     list<TesselPoint*> *connectedClosestPoints = GetCircleOfConnectedPoints(trianglePoints[0], x);
     3029    set<TesselPoint*> *connectedPoints = GetAllConnectedPoints(trianglePoints[0]);
     3030    TesselPointList *connectedClosestPoints = GetCircleOfSetOfPoints(connectedPoints, trianglePoints[0], x);
     3031    delete(connectedPoints);
    26933032    if (connectedClosestPoints != NULL) {
    26943033      trianglePoints[1] = connectedClosestPoints->front();
     
    26983037          eLog() << Verbose(1) << "IsInnerPoint encounters serious error, point " << i << " not found." << endl;
    26993038        }
    2700         //Log() << Verbose(2) << "List of triangle points:" << endl;
    2701         //Log() << Verbose(3) << *trianglePoints[i] << endl;
     3039        //Log() << Verbose(1) << "List of triangle points:" << endl;
     3040        //Log() << Verbose(2) << *trianglePoints[i] << endl;
    27023041      }
    27033042
    27043043      triangles = FindTriangles(trianglePoints);
    2705       Log() << Verbose(2) << "List of possible triangles:" << endl;
     3044      Log() << Verbose(1) << "List of possible triangles:" << endl;
    27063045      for(list<BoundaryTriangleSet*>::iterator Runner = triangles->begin(); Runner != triangles->end(); Runner++)
    2707         Log() << Verbose(3) << **Runner << endl;
     3046        Log() << Verbose(2) << **Runner << endl;
    27083047
    27093048      delete(connectedClosestPoints);
    27103049    } else {
    27113050      triangles = NULL;
    2712       Log() << Verbose(1) << "There is no circle of connected points!" << endl;
     3051      eLog() << Verbose(2) << "There is no circle of connected points!" << endl;
    27133052    }
    27143053  }
     
    27303069class BoundaryTriangleSet * Tesselation::FindClosestTriangleToPoint(const Vector *x, const LinkedCell* LC) const
    27313070{
     3071        Info FunctionInfo(__func__);
    27323072  class BoundaryTriangleSet *result = NULL;
    27333073  list<BoundaryTriangleSet*> *triangles = FindClosestTrianglesToPoint(x, LC);
     
    27393079  if (triangles->size() == 1) { // there is no degenerate case
    27403080    result = triangles->front();
    2741     Log() << Verbose(2) << "Normal Vector of this triangle is " << result->NormalVector << "." << endl;
     3081    Log() << Verbose(1) << "Normal Vector of this triangle is " << result->NormalVector << "." << endl;
    27423082  } else {
    27433083    result = triangles->front();
    27443084    result->GetCenter(&Center);
    27453085    Center.SubtractVector(x);
    2746     Log() << Verbose(2) << "Normal Vector of this front side is " << result->NormalVector << "." << endl;
     3086    Log() << Verbose(1) << "Normal Vector of this front side is " << result->NormalVector << "." << endl;
    27473087    if (Center.ScalarProduct(&result->NormalVector) < 0) {
    27483088      result = triangles->back();
    2749       Log() << Verbose(2) << "Normal Vector of this back side is " << result->NormalVector << "." << endl;
     3089      Log() << Verbose(1) << "Normal Vector of this back side is " << result->NormalVector << "." << endl;
    27503090      if (Center.ScalarProduct(&result->NormalVector) < 0) {
    27513091        eLog() << Verbose(1) << "Front and back side yield NormalVector in wrong direction!" << endl;
     
    27663106bool Tesselation::IsInnerPoint(const Vector &Point, const LinkedCell* const LC) const
    27673107{
     3108        Info FunctionInfo(__func__);
    27683109  class BoundaryTriangleSet *result = FindClosestTriangleToPoint(&Point, LC);
    27693110  Vector Center;
     
    27753116
    27763117  result->GetCenter(&Center);
    2777   Log() << Verbose(3) << "INFO: Central point of the triangle is " << Center << "." << endl;
     3118  Log() << Verbose(2) << "INFO: Central point of the triangle is " << Center << "." << endl;
    27783119  Center.SubtractVector(&Point);
    2779   Log() << Verbose(3) << "INFO: Vector from center to point to test is " << Center << "." << endl;
     3120  Log() << Verbose(2) << "INFO: Vector from center to point to test is " << Center << "." << endl;
    27803121  if (Center.ScalarProduct(&result->NormalVector) > -MYEPSILON) {
    27813122    Log() << Verbose(1) << Point << " is an inner point." << endl;
     
    27963137bool Tesselation::IsInnerPoint(const TesselPoint * const Point, const LinkedCell* const LC) const
    27973138{
     3139        Info FunctionInfo(__func__);
    27983140  return IsInnerPoint(*(Point->node), LC);
    27993141}
     
    28073149set<TesselPoint*> * Tesselation::GetAllConnectedPoints(const TesselPoint* const Point) const
    28083150{
     3151        Info FunctionInfo(__func__);
    28093152  set<TesselPoint*> *connectedPoints = new set<TesselPoint*>;
    28103153  class BoundaryPointSet *ReferencePoint = NULL;
    28113154  TesselPoint* current;
    28123155  bool takePoint = false;
    2813 
    2814   Log() << Verbose(3) << "Begin of GetAllConnectedPoints" << endl;
    28153156
    28163157  // find the respective boundary point
     
    28193160    ReferencePoint = PointRunner->second;
    28203161  } else {
    2821     Log() << Verbose(2) << "GetAllConnectedPoints() could not find the BoundaryPoint belonging to " << *Point << "." << endl;
     3162    eLog() << Verbose(2) << "GetAllConnectedPoints() could not find the BoundaryPoint belonging to " << *Point << "." << endl;
    28223163    ReferencePoint = NULL;
    28233164  }
     
    28433184
    28443185   if (takePoint) {
    2845      Log() << Verbose(5) << "INFO: Endpoint " << *current << " of line " << *(findLines->second) << " is enlisted." << endl;
     3186     Log() << Verbose(1) << "INFO: Endpoint " << *current << " of line " << *(findLines->second) << " is enlisted." << endl;
    28463187     connectedPoints->insert(current);
    28473188   }
     
    28553196  }
    28563197
    2857   Log() << Verbose(3) << "End of GetAllConnectedPoints" << endl;
    28583198  return connectedPoints;
    28593199};
     
    28673207 *
    28683208 * @param *out output stream for debugging
     3209 * @param *SetOfNeighbours all points for which the angle should be calculated
    28693210 * @param *Point of which get all connected points
    28703211 * @param *Reference Reference vector for zero angle or NULL for no preference
    28713212 * @return list of the all points linked to the provided one
    28723213 */
    2873 list<TesselPoint*> * Tesselation::GetCircleOfConnectedPoints(const TesselPoint* const Point, const Vector * const Reference) const
    2874 {
     3214list<TesselPoint*> * Tesselation::GetCircleOfSetOfPoints(set<TesselPoint*> *SetOfNeighbours, const TesselPoint* const Point, const Vector * const Reference) const
     3215{
     3216        Info FunctionInfo(__func__);
    28753217  map<double, TesselPoint*> anglesOfPoints;
    2876   set<TesselPoint*> *connectedPoints = GetAllConnectedPoints(Point);
    28773218  list<TesselPoint*> *connectedCircle = new list<TesselPoint*>;
    28783219  Vector center;
     
    28823223  Vector helper;
    28833224
    2884   if (connectedPoints == NULL) {
    2885     Log() << Verbose(2) << "Could not find any connected points!" << endl;
     3225  if (SetOfNeighbours == NULL) {
     3226    eLog() << Verbose(2) << "Could not find any connected points!" << endl;
    28863227    delete(connectedCircle);
    28873228    return NULL;
    28883229  }
    2889   Log() << Verbose(2) << "Begin of GetCircleOfConnectedPoints" << endl;
    28903230
    28913231  // calculate central point
    2892   for (set<TesselPoint*>::const_iterator TesselRunner = connectedPoints->begin(); TesselRunner != connectedPoints->end(); TesselRunner++)
     3232  for (set<TesselPoint*>::const_iterator TesselRunner = SetOfNeighbours->begin(); TesselRunner != SetOfNeighbours->end(); TesselRunner++)
    28933233    center.AddVector((*TesselRunner)->node);
    28943234  //Log() << Verbose(0) << "Summed vectors " << center << "; number of points " << connectedPoints.size()
    28953235  //  << "; scale factor " << 1.0/connectedPoints.size();
    2896   center.Scale(1.0/connectedPoints->size());
    2897   Log() << Verbose(4) << "INFO: Calculated center of all circle points is " << center << "." << endl;
     3236  center.Scale(1.0/SetOfNeighbours->size());
     3237  Log() << Verbose(1) << "INFO: Calculated center of all circle points is " << center << "." << endl;
    28983238
    28993239  // projection plane of the circle is at the closes Point and normal is pointing away from center of all circle points
     
    29013241  PlaneNormal.SubtractVector(&center);
    29023242  PlaneNormal.Normalize();
    2903   Log() << Verbose(4) << "INFO: Calculated plane normal of circle is " << PlaneNormal << "." << endl;
     3243  Log() << Verbose(1) << "INFO: Calculated plane normal of circle is " << PlaneNormal << "." << endl;
    29043244
    29053245  // construct one orthogonal vector
     
    29103250  }
    29113251  if ((Reference == NULL) || (AngleZero.NormSquared() < MYEPSILON )) {
    2912     Log() << Verbose(4) << "Using alternatively " << *(*connectedPoints->begin())->node << " as angle 0 referencer." << endl;
    2913     AngleZero.CopyVector((*connectedPoints->begin())->node);
     3252    Log() << Verbose(1) << "Using alternatively " << *(*SetOfNeighbours->begin())->node << " as angle 0 referencer." << endl;
     3253    AngleZero.CopyVector((*SetOfNeighbours->begin())->node);
    29143254    AngleZero.SubtractVector(Point->node);
    29153255    AngleZero.ProjectOntoPlane(&PlaneNormal);
     
    29193259    }
    29203260  }
    2921   Log() << Verbose(4) << "INFO: Reference vector on this plane representing angle 0 is " << AngleZero << "." << endl;
     3261  Log() << Verbose(1) << "INFO: Reference vector on this plane representing angle 0 is " << AngleZero << "." << endl;
    29223262  if (AngleZero.NormSquared() > MYEPSILON)
    29233263    OrthogonalVector.MakeNormalVector(&PlaneNormal, &AngleZero);
    29243264  else
    29253265    OrthogonalVector.MakeNormalVector(&PlaneNormal);
    2926   Log() << Verbose(4) << "INFO: OrthogonalVector on plane is " << OrthogonalVector << "." << endl;
     3266  Log() << Verbose(1) << "INFO: OrthogonalVector on plane is " << OrthogonalVector << "." << endl;
    29273267
    29283268  // go through all connected points and calculate angle
    2929   for (set<TesselPoint*>::iterator listRunner = connectedPoints->begin(); listRunner != connectedPoints->end(); listRunner++) {
     3269  for (set<TesselPoint*>::iterator listRunner = SetOfNeighbours->begin(); listRunner != SetOfNeighbours->end(); listRunner++) {
    29303270    helper.CopyVector((*listRunner)->node);
    29313271    helper.SubtractVector(Point->node);
    29323272    helper.ProjectOntoPlane(&PlaneNormal);
    29333273    double angle = GetAngle(helper, AngleZero, OrthogonalVector);
    2934     Log() << Verbose(3) << "INFO: Calculated angle is " << angle << " for point " << **listRunner << "." << endl;
     3274    Log() << Verbose(0) << "INFO: Calculated angle is " << angle << " for point " << **listRunner << "." << endl;
    29353275    anglesOfPoints.insert(pair<double, TesselPoint*>(angle, (*listRunner)));
    29363276  }
     
    29393279    connectedCircle->push_back(AngleRunner->second);
    29403280  }
    2941 
    2942   delete(connectedPoints);
    2943 
    2944   Log() << Verbose(2) << "End of GetCircleOfConnectedPoints" << endl;
    29453281
    29463282  return connectedCircle;
     
    29553291list<list<TesselPoint*> *> * Tesselation::GetPathsOfConnectedPoints(const TesselPoint* const Point) const
    29563292{
     3293        Info FunctionInfo(__func__);
    29573294  map<double, TesselPoint*> anglesOfPoints;
    29583295  list<list<TesselPoint*> *> *ListOfPaths = new list<list<TesselPoint*> *>;
     
    29993336        StartLine = CurrentLine;
    30003337        CurrentPoint = CurrentLine->GetOtherEndpoint(ReferencePoint);
    3001         Log() << Verbose(3)<< "INFO: Beginning path retrieval at " << *CurrentPoint << " of line " << *CurrentLine << "." << endl;
     3338        Log() << Verbose(1)<< "INFO: Beginning path retrieval at " << *CurrentPoint << " of line " << *CurrentLine << "." << endl;
    30023339        do {
    30033340          // push current one
    3004           Log() << Verbose(3) << "INFO: Putting " << *CurrentPoint << " at end of path." << endl;
     3341          Log() << Verbose(1) << "INFO: Putting " << *CurrentPoint << " at end of path." << endl;
    30053342          connectedPath->push_back(CurrentPoint->node);
    30063343
    30073344          // find next triangle
    30083345          for (TriangleMap::iterator Runner = CurrentLine->triangles.begin(); Runner != CurrentLine->triangles.end(); Runner++) {
    3009             Log() << Verbose(3) << "INFO: Inspecting triangle " << *Runner->second << "." << endl;
     3346            Log() << Verbose(1) << "INFO: Inspecting triangle " << *Runner->second << "." << endl;
    30103347            if ((Runner->second != triangle)) { // look for first triangle not equal to old one
    30113348              triangle = Runner->second;
     
    30143351                if (!TriangleRunner->second) {
    30153352                  TriangleRunner->second = true;
    3016                   Log() << Verbose(3) << "INFO: Connecting triangle is " << *triangle << "." << endl;
     3353                  Log() << Verbose(1) << "INFO: Connecting triangle is " << *triangle << "." << endl;
    30173354                  break;
    30183355                } else {
    3019                   Log() << Verbose(3) << "INFO: Skipping " << *triangle << ", as we have already visited it." << endl;
     3356                  Log() << Verbose(1) << "INFO: Skipping " << *triangle << ", as we have already visited it." << endl;
    30203357                  triangle = NULL;
    30213358                }
     
    30323369            if ((triangle->lines[i] != CurrentLine) && (triangle->lines[i]->ContainsBoundaryPoint(ReferencePoint))) { // not the current line and still containing Point
    30333370              CurrentLine = triangle->lines[i];
    3034               Log() << Verbose(3) << "INFO: Connecting line is " << *CurrentLine << "." << endl;
     3371              Log() << Verbose(1) << "INFO: Connecting line is " << *CurrentLine << "." << endl;
    30353372              break;
    30363373            }
     
    30463383        } while (CurrentLine != StartLine);
    30473384        // last point is missing, as it's on start line
    3048         Log() << Verbose(3) << "INFO: Putting " << *CurrentPoint << " at end of path." << endl;
     3385        Log() << Verbose(1) << "INFO: Putting " << *CurrentPoint << " at end of path." << endl;
    30493386        if (StartLine->GetOtherEndpoint(ReferencePoint)->node != connectedPath->back())
    30503387          connectedPath->push_back(StartLine->GetOtherEndpoint(ReferencePoint)->node);
     
    30523389        ListOfPaths->push_back(connectedPath);
    30533390      } else {
    3054         Log() << Verbose(3) << "INFO: Skipping " << *runner->second << ", as we have already visited it." << endl;
     3391        Log() << Verbose(1) << "INFO: Skipping " << *runner->second << ", as we have already visited it." << endl;
    30553392      }
    30563393    }
     
    30703407list<list<TesselPoint*> *> * Tesselation::GetClosedPathsOfConnectedPoints(const TesselPoint* const Point) const
    30713408{
     3409        Info FunctionInfo(__func__);
    30723410  list<list<TesselPoint*> *> *ListofPaths = GetPathsOfConnectedPoints(Point);
    30733411  list<list<TesselPoint*> *> *ListofClosedPaths = new list<list<TesselPoint*> *>;
     
    30833421    connectedPath = *ListRunner;
    30843422
    3085     Log() << Verbose(2) << "INFO: Current path is " << connectedPath << "." << endl;
     3423    Log() << Verbose(1) << "INFO: Current path is " << connectedPath << "." << endl;
    30863424
    30873425    // go through list, look for reappearance of starting Point and count
     
    30933431      if ((*CircleRunner == *CircleStart) && (CircleRunner != CircleStart)) { // is not the very first point
    30943432        // we have a closed circle from Marker to new Marker
    3095         Log() << Verbose(3) << count+1 << ". closed path consists of: ";
     3433        Log() << Verbose(1) << count+1 << ". closed path consists of: ";
    30963434        newPath = new list<TesselPoint*>;
    30973435        list<TesselPoint*>::iterator CircleSprinter = Marker;
     
    31093447    }
    31103448  }
    3111   Log() << Verbose(3) << "INFO: " << count << " closed additional path(s) have been created." << endl;
     3449  Log() << Verbose(1) << "INFO: " << count << " closed additional path(s) have been created." << endl;
    31123450
    31133451  // delete list of paths
     
    31313469set<BoundaryTriangleSet*> *Tesselation::GetAllTriangles(const BoundaryPointSet * const Point) const
    31323470{
     3471        Info FunctionInfo(__func__);
    31333472  set<BoundaryTriangleSet*> *connectedTriangles = new set<BoundaryTriangleSet*>;
    31343473
     
    31693508    return 0.;
    31703509  } else
    3171     Log() << Verbose(2) << "Removing point " << *point << " from tesselated boundary ..." << endl;
     3510    Log() << Verbose(0) << "Removing point " << *point << " from tesselated boundary ..." << endl;
    31723511
    31733512  // copy old location for the volume
     
    31993538  NormalVector.Zero();
    32003539  for (map<class BoundaryTriangleSet *, int>::iterator Runner = Candidates.begin(); Runner != Candidates.end(); Runner++) {
    3201     Log() << Verbose(3) << "INFO: Removing triangle " << *(Runner->first) << "." << endl;
     3540    Log() << Verbose(1) << "INFO: Removing triangle " << *(Runner->first) << "." << endl;
    32023541    NormalVector.SubtractVector(&Runner->first->NormalVector); // has to point inward
    32033542    RemoveTesselationTriangle(Runner->first);
     
    32293568        smallestangle = 0.;
    32303569        for (MiddleNode = connectedPath->begin(); MiddleNode != connectedPath->end(); MiddleNode++) {
    3231           Log() << Verbose(3) << "INFO: MiddleNode is " << **MiddleNode << "." << endl;
     3570          Log() << Verbose(1) << "INFO: MiddleNode is " << **MiddleNode << "." << endl;
    32323571          // construct vectors to next and previous neighbour
    32333572          StartNode = MiddleNode;
     
    32573596        MiddleNode = EndNode;
    32583597        if (MiddleNode == connectedPath->end()) {
    3259           Log() << Verbose(1) << "CRITICAL: Could not find a smallest angle!" << endl;
    3260           exit(255);
     3598          eLog() << Verbose(0) << "CRITICAL: Could not find a smallest angle!" << endl;
     3599          performCriticalExit();
    32613600        }
    32623601        StartNode = MiddleNode;
     
    32673606        if (EndNode == connectedPath->end())
    32683607          EndNode = connectedPath->begin();
    3269         Log() << Verbose(4) << "INFO: StartNode is " << **StartNode << "." << endl;
    3270         Log() << Verbose(4) << "INFO: MiddleNode is " << **MiddleNode << "." << endl;
    3271         Log() << Verbose(4) << "INFO: EndNode is " << **EndNode << "." << endl;
    3272         Log() << Verbose(3) << "INFO: Attempting to create triangle " << (*StartNode)->Name << ", " << (*MiddleNode)->Name << " and " << (*EndNode)->Name << "." << endl;
     3608        Log() << Verbose(2) << "INFO: StartNode is " << **StartNode << "." << endl;
     3609        Log() << Verbose(2) << "INFO: MiddleNode is " << **MiddleNode << "." << endl;
     3610        Log() << Verbose(2) << "INFO: EndNode is " << **EndNode << "." << endl;
     3611        Log() << Verbose(1) << "INFO: Attempting to create triangle " << (*StartNode)->Name << ", " << (*MiddleNode)->Name << " and " << (*EndNode)->Name << "." << endl;
    32733612        TriangleCandidates[0] = *StartNode;
    32743613        TriangleCandidates[1] = *MiddleNode;
     
    32763615        triangle = GetPresentTriangle(TriangleCandidates);
    32773616        if (triangle != NULL) {
    3278           eLog() << Verbose(2) << "New triangle already present, skipping!" << endl;
     3617          eLog() << Verbose(0) << "New triangle already present, skipping!" << endl;
    32793618          StartNode++;
    32803619          MiddleNode++;
     
    32883627          continue;
    32893628        }
    3290         Log() << Verbose(5) << "Adding new triangle points."<< endl;
     3629        Log() << Verbose(3) << "Adding new triangle points."<< endl;
    32913630        AddTesselationPoint(*StartNode, 0);
    32923631        AddTesselationPoint(*MiddleNode, 1);
    32933632        AddTesselationPoint(*EndNode, 2);
    3294         Log() << Verbose(5) << "Adding new triangle lines."<< endl;
     3633        Log() << Verbose(3) << "Adding new triangle lines."<< endl;
    32953634        AddTesselationLine(TPS[0], TPS[1], 0);
    32963635        AddTesselationLine(TPS[0], TPS[2], 1);
     
    33073646        // prepare nodes for next triangle
    33083647        StartNode = EndNode;
    3309         Log() << Verbose(4) << "Removing " << **MiddleNode << " from closed path, remaining points: " << connectedPath->size() << "." << endl;
     3648        Log() << Verbose(2) << "Removing " << **MiddleNode << " from closed path, remaining points: " << connectedPath->size() << "." << endl;
    33103649        connectedPath->remove(*MiddleNode); // remove the middle node (it is surrounded by triangles)
    33113650        if (connectedPath->size() == 2) { // we are done
     
    33143653          break;
    33153654        } else if (connectedPath->size() < 2) { // something's gone wrong!
    3316           Log() << Verbose(1) << "CRITICAL: There are only two endpoints left!" << endl;
    3317           exit(255);
     3655          eLog() << Verbose(0) << "CRITICAL: There are only two endpoints left!" << endl;
     3656          performCriticalExit();
    33183657        } else {
    33193658          MiddleNode = StartNode;
     
    33433682          if (maxgain != 0) {
    33443683            volume += maxgain;
    3345             Log() << Verbose(3) << "Flipping baseline with highest volume" << **Candidate << "." << endl;
     3684            Log() << Verbose(1) << "Flipping baseline with highest volume" << **Candidate << "." << endl;
    33463685            OtherBase = FlipBaseline(*Candidate);
    33473686            NewLines.erase(Candidate);
     
    33543693      delete(connectedPath);
    33553694    }
    3356     Log() << Verbose(1) << count << " triangles were created." << endl;
     3695    Log() << Verbose(0) << count << " triangles were created." << endl;
    33573696  } else {
    33583697    while (!ListOfClosedPaths->empty()) {
     
    33623701      delete(connectedPath);
    33633702    }
    3364     Log() << Verbose(1) << "No need to create any triangles." << endl;
     3703    Log() << Verbose(0) << "No need to create any triangles." << endl;
    33653704  }
    33663705  delete(ListOfClosedPaths);
    33673706
    3368   Log() << Verbose(1) << "Removed volume is " << volume << "." << endl;
     3707  Log() << Verbose(0) << "Removed volume is " << volume << "." << endl;
    33693708
    33703709  return volume;
     
    33833722list<BoundaryTriangleSet*> *Tesselation::FindTriangles(const TesselPoint* const Points[3]) const
    33843723{
     3724        Info FunctionInfo(__func__);
    33853725  list<BoundaryTriangleSet*> *result = new list<BoundaryTriangleSet*>;
    33863726  LineMap::const_iterator FindLine;
     
    34233763}
    34243764
     3765struct BoundaryLineSetCompare {
     3766  bool operator() (const BoundaryLineSet * const a, const BoundaryLineSet * const b) {
     3767    int lowerNra = -1;
     3768    int lowerNrb = -1;
     3769
     3770    if (a->endpoints[0] < a->endpoints[1])
     3771      lowerNra = 0;
     3772    else
     3773      lowerNra = 1;
     3774
     3775    if (b->endpoints[0] < b->endpoints[1])
     3776      lowerNrb = 0;
     3777    else
     3778      lowerNrb = 1;
     3779
     3780    if (a->endpoints[lowerNra] < b->endpoints[lowerNrb])
     3781      return true;
     3782    else if (a->endpoints[lowerNra] > b->endpoints[lowerNrb])
     3783      return false;
     3784    else {  // both lower-numbered endpoints are the same ...
     3785     if (a->endpoints[(lowerNra+1)%2] < b->endpoints[(lowerNrb+1)%2])
     3786       return true;
     3787     else if (a->endpoints[(lowerNra+1)%2] > b->endpoints[(lowerNrb+1)%2])
     3788       return false;
     3789    }
     3790    return false;
     3791  };
     3792};
     3793
     3794#define UniqueLines set < class BoundaryLineSet *, BoundaryLineSetCompare>
     3795
    34253796/**
    34263797 * Finds all degenerated lines within the tesselation structure.
     
    34313802map<int, int> * Tesselation::FindAllDegeneratedLines()
    34323803{
    3433   map<int, class BoundaryLineSet *> AllLines;
     3804        Info FunctionInfo(__func__);
     3805        UniqueLines AllLines;
    34343806  map<int, int> * DegeneratedLines = new map<int, int>;
    34353807
    34363808  // sanity check
    34373809  if (LinesOnBoundary.empty()) {
    3438     Log() << Verbose(1) << "Warning: FindAllDegeneratedTriangles() was called without any tesselation structure.";
     3810    eLog() << Verbose(2) << "FindAllDegeneratedTriangles() was called without any tesselation structure.";
    34393811    return DegeneratedLines;
    34403812  }
    34413813
    34423814  LineMap::iterator LineRunner1;
    3443   pair<LineMap::iterator, bool> tester;
     3815  pair< UniqueLines::iterator, bool> tester;
    34443816  for (LineRunner1 = LinesOnBoundary.begin(); LineRunner1 != LinesOnBoundary.end(); ++LineRunner1) {
    3445     tester = AllLines.insert( pair<int,BoundaryLineSet *> (LineRunner1->second->endpoints[0]->Nr, LineRunner1->second) );
    3446     if ((!tester.second) && (tester.first->second->endpoints[1]->Nr == LineRunner1->second->endpoints[1]->Nr)) { // found degenerated line
    3447       DegeneratedLines->insert ( pair<int, int> (LineRunner1->second->Nr, tester.first->second->Nr) );
    3448       DegeneratedLines->insert ( pair<int, int> (tester.first->second->Nr, LineRunner1->second->Nr) );
     3817    tester = AllLines.insert( LineRunner1->second );
     3818    if (!tester.second) { // found degenerated line
     3819      DegeneratedLines->insert ( pair<int, int> (LineRunner1->second->Nr, (*tester.first)->Nr) );
     3820      DegeneratedLines->insert ( pair<int, int> ((*tester.first)->Nr, LineRunner1->second->Nr) );
    34493821    }
    34503822  }
     
    34523824  AllLines.clear();
    34533825
    3454   Log() << Verbose(1) << "FindAllDegeneratedLines() found " << DegeneratedLines->size() << " lines." << endl;
     3826  Log() << Verbose(0) << "FindAllDegeneratedLines() found " << DegeneratedLines->size() << " lines." << endl;
    34553827  map<int,int>::iterator it;
    3456   for (it = DegeneratedLines->begin(); it != DegeneratedLines->end(); it++)
    3457       Log() << Verbose(2) << (*it).first << " => " << (*it).second << endl;
     3828  for (it = DegeneratedLines->begin(); it != DegeneratedLines->end(); it++) {
     3829    const LineMap::const_iterator Line1 = LinesOnBoundary.find((*it).first);
     3830    const LineMap::const_iterator Line2 = LinesOnBoundary.find((*it).second);
     3831    if (Line1 != LinesOnBoundary.end() && Line2 != LinesOnBoundary.end())
     3832      Log() << Verbose(0) << *Line1->second << " => " << *Line2->second << endl;
     3833    else
     3834      eLog() << Verbose(1) << "Either " << (*it).first << " or " << (*it).second << " are not in LinesOnBoundary!" << endl;
     3835  }
    34583836
    34593837  return DegeneratedLines;
     
    34683846map<int, int> * Tesselation::FindAllDegeneratedTriangles()
    34693847{
     3848        Info FunctionInfo(__func__);
    34703849  map<int, int> * DegeneratedLines = FindAllDegeneratedLines();
    34713850  map<int, int> * DegeneratedTriangles = new map<int, int>;
     
    34953874  delete(DegeneratedLines);
    34963875
    3497   Log() << Verbose(1) << "FindAllDegeneratedTriangles() found " << DegeneratedTriangles->size() << " triangles:" << endl;
     3876  Log() << Verbose(0) << "FindAllDegeneratedTriangles() found " << DegeneratedTriangles->size() << " triangles:" << endl;
    34983877  map<int,int>::iterator it;
    34993878  for (it = DegeneratedTriangles->begin(); it != DegeneratedTriangles->end(); it++)
    3500       Log() << Verbose(2) << (*it).first << " => " << (*it).second << endl;
     3879      Log() << Verbose(0) << (*it).first << " => " << (*it).second << endl;
    35013880
    35023881  return DegeneratedTriangles;
     
    35093888void Tesselation::RemoveDegeneratedTriangles()
    35103889{
     3890        Info FunctionInfo(__func__);
    35113891  map<int, int> * DegeneratedTriangles = FindAllDegeneratedTriangles();
    35123892  TriangleMap::iterator finder;
    35133893  BoundaryTriangleSet *triangle = NULL, *partnerTriangle = NULL;
    35143894  int count  = 0;
    3515 
    3516   Log() << Verbose(1) << "Begin of RemoveDegeneratedTriangles" << endl;
    35173895
    35183896  for (map<int, int>::iterator TriangleKeyRunner = DegeneratedTriangles->begin();
     
    35733951      // erase the pair
    35743952      count += (int) DegeneratedTriangles->erase(triangle->Nr);
    3575       Log() << Verbose(1) << "RemoveDegeneratedTriangles() removes triangle " << *triangle << "." << endl;
     3953      Log() << Verbose(0) << "RemoveDegeneratedTriangles() removes triangle " << *triangle << "." << endl;
    35763954      RemoveTesselationTriangle(triangle);
    35773955      count += (int) DegeneratedTriangles->erase(partnerTriangle->Nr);
    3578       Log() << Verbose(1) << "RemoveDegeneratedTriangles() removes triangle " << *partnerTriangle << "." << endl;
     3956      Log() << Verbose(0) << "RemoveDegeneratedTriangles() removes triangle " << *partnerTriangle << "." << endl;
    35793957      RemoveTesselationTriangle(partnerTriangle);
    35803958    } else {
    3581       Log() << Verbose(1) << "RemoveDegeneratedTriangles() does not remove triangle " << *triangle
     3959      Log() << Verbose(0) << "RemoveDegeneratedTriangles() does not remove triangle " << *triangle
    35823960        << " and its partner " << *partnerTriangle << " because it is essential for at"
    35833961        << " least one of the endpoints to be kept in the tesselation structure." << endl;
     
    35883966    LastTriangle = NULL;
    35893967
    3590   Log() << Verbose(1) << "RemoveDegeneratedTriangles() removed " << count << " triangles:" << endl;
    3591   Log() << Verbose(1) << "End of RemoveDegeneratedTriangles" << endl;
     3968  Log() << Verbose(0) << "RemoveDegeneratedTriangles() removed " << count << " triangles:" << endl;
    35923969}
    35933970
     
    36023979void Tesselation::AddBoundaryPointByDegeneratedTriangle(class TesselPoint *point, LinkedCell *LC)
    36033980{
    3604   Log() << Verbose(2) << "Begin of AddBoundaryPointByDegeneratedTriangle" << endl;
    3605 
     3981        Info FunctionInfo(__func__);
    36063982  // find nearest boundary point
    36073983  class TesselPoint *BackupPoint = NULL;
     
    36193995    return;
    36203996  }
    3621   Log() << Verbose(2) << "Nearest point on boundary is " << NearestPoint->Name << "." << endl;
     3997  Log() << Verbose(0) << "Nearest point on boundary is " << NearestPoint->Name << "." << endl;
    36223998
    36233999  // go through its lines and find the best one to split
     
    36524028
    36534029  // create new triangle to connect point (connects automatically with the missing spot of the chosen line)
    3654   Log() << Verbose(5) << "Adding new triangle points."<< endl;
     4030  Log() << Verbose(2) << "Adding new triangle points."<< endl;
    36554031  AddTesselationPoint((BestLine->endpoints[0]->node), 0);
    36564032  AddTesselationPoint((BestLine->endpoints[1]->node), 1);
    36574033  AddTesselationPoint(point, 2);
    3658   Log() << Verbose(5) << "Adding new triangle lines."<< endl;
     4034  Log() << Verbose(2) << "Adding new triangle lines."<< endl;
    36594035  AddTesselationLine(TPS[0], TPS[1], 0);
    36604036  AddTesselationLine(TPS[0], TPS[2], 1);
     
    36634039  BTS->GetNormalVector(TempTriangle->NormalVector);
    36644040  BTS->NormalVector.Scale(-1.);
    3665   Log() << Verbose(3) << "INFO: NormalVector of new triangle is " << BTS->NormalVector << "." << endl;
     4041  Log() << Verbose(1) << "INFO: NormalVector of new triangle is " << BTS->NormalVector << "." << endl;
    36664042  AddTesselationTriangle();
    36674043
    36684044  // create other side of this triangle and close both new sides of the first created triangle
    3669   Log() << Verbose(5) << "Adding new triangle points."<< endl;
     4045  Log() << Verbose(2) << "Adding new triangle points."<< endl;
    36704046  AddTesselationPoint((BestLine->endpoints[0]->node), 0);
    36714047  AddTesselationPoint((BestLine->endpoints[1]->node), 1);
    36724048  AddTesselationPoint(point, 2);
    3673   Log() << Verbose(5) << "Adding new triangle lines."<< endl;
     4049  Log() << Verbose(2) << "Adding new triangle lines."<< endl;
    36744050  AddTesselationLine(TPS[0], TPS[1], 0);
    36754051  AddTesselationLine(TPS[0], TPS[2], 1);
     
    36774053  BTS = new class BoundaryTriangleSet(BLS, TrianglesOnBoundaryCount);
    36784054  BTS->GetNormalVector(TempTriangle->NormalVector);
    3679   Log() << Verbose(3) << "INFO: NormalVector of other new triangle is " << BTS->NormalVector << "." << endl;
     4055  Log() << Verbose(1) << "INFO: NormalVector of other new triangle is " << BTS->NormalVector << "." << endl;
    36804056  AddTesselationTriangle();
    36814057
     
    36844060    if ((BTS->lines[i]->ContainsBoundaryPoint(BestLine->endpoints[0])) && (BTS->lines[i]->ContainsBoundaryPoint(BestLine->endpoints[1]))) {
    36854061      if (BestLine == BTS->lines[i]){
    3686         Log() << Verbose(1) << "CRITICAL: BestLine is same as found line, something's wrong here!" << endl;
    3687         exit(255);
     4062        eLog() << Verbose(0) << "BestLine is same as found line, something's wrong here!" << endl;
     4063        performCriticalExit();
    36884064      }
    36894065      BTS->lines[i]->triangles.insert( pair<int, class BoundaryTriangleSet *> (TempTriangle->Nr, TempTriangle) );
     
    36924068    }
    36934069  }
    3694 
    3695   // exit
    3696   Log() << Verbose(2) << "End of AddBoundaryPointByDegeneratedTriangle" << endl;
    36974070};
    36984071
     
    37044077void Tesselation::Output(const char *filename, const PointCloud * const cloud)
    37054078{
     4079        Info FunctionInfo(__func__);
    37064080  ofstream *tempstream = NULL;
    37074081  string NameofTempFile;
     
    37164090      NameofTempFile.erase(npos, 1);
    37174091      NameofTempFile.append(TecplotSuffix);
    3718       Log() << Verbose(1) << "Writing temporary non convex hull to file " << NameofTempFile << ".\n";
     4092      Log() << Verbose(0) << "Writing temporary non convex hull to file " << NameofTempFile << ".\n";
    37194093      tempstream = new ofstream(NameofTempFile.c_str(), ios::trunc);
    37204094      WriteTecplotFile(tempstream, this, cloud, TriangleFilesWritten);
     
    37304104      NameofTempFile.erase(npos, 1);
    37314105      NameofTempFile.append(Raster3DSuffix);
    3732       Log() << Verbose(1) << "Writing temporary non convex hull to file " << NameofTempFile << ".\n";
     4106      Log() << Verbose(0) << "Writing temporary non convex hull to file " << NameofTempFile << ".\n";
    37334107      tempstream = new ofstream(NameofTempFile.c_str(), ios::trunc);
    37344108      WriteRaster3dFile(tempstream, this, cloud);
     
    37424116    TriangleFilesWritten++;
    37434117};
     4118
     4119struct BoundaryPolygonSetCompare {
     4120  bool operator()(const BoundaryPolygonSet * s1, const BoundaryPolygonSet * s2) const {
     4121    if (s1->endpoints.size() < s2->endpoints.size())
     4122      return true;
     4123    else if (s1->endpoints.size() > s2->endpoints.size())
     4124      return false;
     4125    else { // equality of number of endpoints
     4126      PointSet::const_iterator Walker1 = s1->endpoints.begin();
     4127      PointSet::const_iterator Walker2 = s2->endpoints.begin();
     4128      while ((Walker1 != s1->endpoints.end()) || (Walker2 != s2->endpoints.end())) {
     4129        if ((*Walker1)->Nr < (*Walker2)->Nr)
     4130          return true;
     4131        else if ((*Walker1)->Nr > (*Walker2)->Nr)
     4132          return false;
     4133        Walker1++;
     4134        Walker2++;
     4135      }
     4136      return false;
     4137    }
     4138  }
     4139};
     4140
     4141#define UniquePolygonSet set < BoundaryPolygonSet *, BoundaryPolygonSetCompare>
     4142
     4143/** Finds all degenerated polygons and calls ReTesselateDegeneratedPolygon()/
     4144 * \return number of polygons found
     4145 */
     4146int Tesselation::CorrectAllDegeneratedPolygons()
     4147{
     4148  Info FunctionInfo(__func__);
     4149
     4150  /// 2. Go through all BoundaryPointSet's, check their triangles' NormalVector
     4151  map <int, int> *DegeneratedTriangles = FindAllDegeneratedTriangles();
     4152  set < BoundaryPointSet *> EndpointCandidateList;
     4153  pair < set < BoundaryPointSet *>::iterator, bool > InsertionTester;
     4154  pair < map < int, Vector *>::iterator, bool > TriangleInsertionTester;
     4155  for (PointMap::const_iterator Runner = PointsOnBoundary.begin(); Runner != PointsOnBoundary.end(); Runner++) {
     4156    Log() << Verbose(0) << "Current point is " << *Runner->second << "." << endl;
     4157    map < int, Vector *> TriangleVectors;
     4158    // gather all NormalVectors
     4159    Log() << Verbose(1) << "Gathering triangles ..." << endl;
     4160    for (LineMap::const_iterator LineRunner = (Runner->second)->lines.begin(); LineRunner != (Runner->second)->lines.end(); LineRunner++)
     4161      for (TriangleMap::const_iterator TriangleRunner = (LineRunner->second)->triangles.begin(); TriangleRunner != (LineRunner->second)->triangles.end(); TriangleRunner++) {
     4162        if (DegeneratedTriangles->find(TriangleRunner->second->Nr) == DegeneratedTriangles->end()) {
     4163          TriangleInsertionTester = TriangleVectors.insert( pair< int, Vector *> ((TriangleRunner->second)->Nr, &((TriangleRunner->second)->NormalVector)) );
     4164          if (TriangleInsertionTester.second)
     4165            Log() << Verbose(1) << " Adding triangle " << *(TriangleRunner->second) << " to triangles to check-list." << endl;
     4166        } else {
     4167          Log() << Verbose(1) << " NOT adding triangle " << *(TriangleRunner->second) << " as it's a simply degenerated one." << endl;
     4168        }
     4169      }
     4170    // check whether there are two that are parallel
     4171    Log() << Verbose(1) << "Finding two parallel triangles ..." << endl;
     4172    for (map < int, Vector *>::iterator VectorWalker = TriangleVectors.begin(); VectorWalker != TriangleVectors.end(); VectorWalker++)
     4173      for (map < int, Vector *>::iterator VectorRunner = VectorWalker; VectorRunner != TriangleVectors.end(); VectorRunner++)
     4174        if (VectorWalker != VectorRunner) { // skip equals
     4175          const double SCP = VectorWalker->second->ScalarProduct(VectorRunner->second);  // ScalarProduct should result in -1. for degenerated triangles
     4176          Log() << Verbose(1) << "Checking " << *VectorWalker->second<< " against " << *VectorRunner->second << ": " << SCP << endl;
     4177          if (fabs(SCP + 1.) < ParallelEpsilon) {
     4178            InsertionTester = EndpointCandidateList.insert((Runner->second));
     4179            if (InsertionTester.second)
     4180              Log() << Verbose(0) << " Adding " << *Runner->second << " to endpoint candidate list." << endl;
     4181            // and break out of both loops
     4182            VectorWalker = TriangleVectors.end();
     4183            VectorRunner = TriangleVectors.end();
     4184            break;
     4185          }
     4186        }
     4187  }
     4188
     4189  /// 3. Find connected endpoint candidates and put them into a polygon
     4190  UniquePolygonSet ListofDegeneratedPolygons;
     4191  BoundaryPointSet *Walker = NULL;
     4192  BoundaryPointSet *OtherWalker = NULL;
     4193  BoundaryPolygonSet *Current = NULL;
     4194  stack <BoundaryPointSet*> ToCheckConnecteds;
     4195  while (!EndpointCandidateList.empty()) {
     4196    Walker = *(EndpointCandidateList.begin());
     4197    if (Current == NULL) {  // create a new polygon with current candidate
     4198      Log() << Verbose(0) << "Starting new polygon set at point " << *Walker << endl;
     4199      Current = new BoundaryPolygonSet;
     4200      Current->endpoints.insert(Walker);
     4201      EndpointCandidateList.erase(Walker);
     4202      ToCheckConnecteds.push(Walker);
     4203    }
     4204
     4205    // go through to-check stack
     4206    while (!ToCheckConnecteds.empty()) {
     4207      Walker = ToCheckConnecteds.top(); // fetch ...
     4208      ToCheckConnecteds.pop(); // ... and remove
     4209      for (LineMap::const_iterator LineWalker = Walker->lines.begin(); LineWalker != Walker->lines.end(); LineWalker++) {
     4210        OtherWalker = (LineWalker->second)->GetOtherEndpoint(Walker);
     4211        Log() << Verbose(1) << "Checking " << *OtherWalker << endl;
     4212        set < BoundaryPointSet *>::iterator Finder = EndpointCandidateList.find(OtherWalker);
     4213        if (Finder != EndpointCandidateList.end()) {  // found a connected partner
     4214          Log() << Verbose(1) << " Adding to polygon." << endl;
     4215          Current->endpoints.insert(OtherWalker);
     4216          EndpointCandidateList.erase(Finder);  // remove from candidates
     4217          ToCheckConnecteds.push(OtherWalker);  // but check its partners too
     4218        } else {
     4219          Log() << Verbose(1) << " is not connected to " << *Walker << endl;
     4220        }
     4221      }
     4222    }
     4223
     4224    Log() << Verbose(0) << "Final polygon is " << *Current << endl;
     4225    ListofDegeneratedPolygons.insert(Current);
     4226    Current = NULL;
     4227  }
     4228
     4229  const int counter = ListofDegeneratedPolygons.size();
     4230
     4231  Log() << Verbose(0) << "The following " << counter << " degenerated polygons have been found: " << endl;
     4232  for (UniquePolygonSet::iterator PolygonRunner = ListofDegeneratedPolygons.begin(); PolygonRunner != ListofDegeneratedPolygons.end(); PolygonRunner++)
     4233    Log() << Verbose(0) << " " << **PolygonRunner << endl;
     4234
     4235  /// 4. Go through all these degenerated polygons
     4236  for (UniquePolygonSet::iterator PolygonRunner = ListofDegeneratedPolygons.begin(); PolygonRunner != ListofDegeneratedPolygons.end(); PolygonRunner++) {
     4237    stack <int> TriangleNrs;
     4238    Vector NormalVector;
     4239    /// 4a. Gather all triangles of this polygon
     4240    TriangleSet *T = (*PolygonRunner)->GetAllContainedTrianglesFromEndpoints();
     4241
     4242    // check whether number is bigger than 2, otherwise it's just a simply degenerated one and nothing to do.
     4243    if (T->size() == 2) {
     4244      Log() << Verbose(1) << " Skipping degenerated polygon, is just a (already simply degenerated) triangle." << endl;
     4245      delete(T);
     4246      continue;
     4247    }
     4248
     4249    // check whether number is even
     4250    // If this case occurs, we have to think about it!
     4251    // The Problem is probably due to two degenerated polygons being connected by a bridging, non-degenerated polygon, as somehow one node has
     4252    // connections to either polygon ...
     4253    if (T->size() % 2 != 0) {
     4254      eLog() << Verbose(0) << " degenerated polygon contains an odd number of triangles, probably contains bridging non-degenerated ones, too!" << endl;
     4255      performCriticalExit();
     4256    }
     4257
     4258    TriangleSet::iterator TriangleWalker = T->begin();  // is the inner iterator
     4259    /// 4a. Get NormalVector for one side (this is "front")
     4260    NormalVector.CopyVector(&(*TriangleWalker)->NormalVector);
     4261    Log() << Verbose(1) << "\"front\" defining triangle is " << **TriangleWalker << " and Normal vector of \"front\" side is " << NormalVector << endl;
     4262    TriangleWalker++;
     4263    TriangleSet::iterator TriangleSprinter = TriangleWalker; // is the inner advanced iterator
     4264    /// 4b. Remove all triangles whose NormalVector is in opposite direction (i.e. "back")
     4265    BoundaryTriangleSet *triangle = NULL;
     4266    while (TriangleSprinter != T->end()) {
     4267      TriangleWalker = TriangleSprinter;
     4268      triangle = *TriangleWalker;
     4269      TriangleSprinter++;
     4270      Log() << Verbose(1) << "Current triangle to test for removal: " << *triangle << endl;
     4271      if (triangle->NormalVector.ScalarProduct(&NormalVector) < 0) { // if from other side, then delete and remove from list
     4272        Log() << Verbose(1) << " Removing ... " << endl;
     4273        TriangleNrs.push(triangle->Nr);
     4274        T->erase(TriangleWalker);
     4275        RemoveTesselationTriangle(triangle);
     4276      } else
     4277        Log() << Verbose(1) << " Keeping ... " << endl;
     4278    }
     4279    /// 4c. Copy all "front" triangles but with inverse NormalVector
     4280    TriangleWalker = T->begin();
     4281    while (TriangleWalker != T->end()) {  // go through all front triangles
     4282      Log() << Verbose(1) << " Re-creating triangle " << **TriangleWalker << " with NormalVector " << (*TriangleWalker)->NormalVector << endl;
     4283      for (int i = 0; i < 3; i++)
     4284        AddTesselationPoint((*TriangleWalker)->endpoints[i]->node, i);
     4285      AddTesselationLine(TPS[0], TPS[1], 0);
     4286      AddTesselationLine(TPS[0], TPS[2], 1);
     4287      AddTesselationLine(TPS[1], TPS[2], 2);
     4288      if (TriangleNrs.empty())
     4289        eLog() << Verbose(0) << "No more free triangle numbers!" << endl;
     4290      BTS = new BoundaryTriangleSet(BLS, TriangleNrs.top()); // copy triangle ...
     4291      AddTesselationTriangle(); // ... and add
     4292      TriangleNrs.pop();
     4293      BTS->NormalVector.CopyVector(&(*TriangleWalker)->NormalVector);
     4294      BTS->NormalVector.Scale(-1.);
     4295      TriangleWalker++;
     4296    }
     4297    if (!TriangleNrs.empty()) {
     4298      eLog() << Verbose(0) << "There have been less triangles created than removed!" << endl;
     4299    }
     4300    delete(T);  // remove the triangleset
     4301  }
     4302
     4303  map<int, int> * SimplyDegeneratedTriangles = FindAllDegeneratedTriangles();
     4304  Log() << Verbose(0) << "Final list of simply degenerated triangles found, containing " << SimplyDegeneratedTriangles->size() << " triangles:" << endl;
     4305  map<int,int>::iterator it;
     4306  for (it = SimplyDegeneratedTriangles->begin(); it != SimplyDegeneratedTriangles->end(); it++)
     4307      Log() << Verbose(0) << (*it).first << " => " << (*it).second << endl;
     4308  delete(SimplyDegeneratedTriangles);
     4309
     4310  /// 5. exit
     4311  UniquePolygonSet::iterator PolygonRunner;
     4312  while (!ListofDegeneratedPolygons.empty()) {
     4313    PolygonRunner = ListofDegeneratedPolygons.begin();
     4314    delete(*PolygonRunner);
     4315    ListofDegeneratedPolygons.erase(PolygonRunner);
     4316  }
     4317
     4318  return counter;
     4319};
  • src/tesselation.hpp

    rebbd3d r1cf5df  
    2323#include <list>
    2424#include <set>
     25#include <stack>
    2526
    2627#include "atom_particleinfo.hpp"
     
    4748#define VRMLSUffix ".wrl"
    4849
     50#define ParallelEpsilon 1e-3
     51
    4952// ======================================================= some template functions =========================================
    5053
    5154#define PointMap map < int, class BoundaryPointSet * >
     55#define PointSet set < class BoundaryPointSet * >
     56#define PointList list < class BoundaryPointSet * >
    5257#define PointPair pair < int, class BoundaryPointSet * >
    5358#define PointTestPair pair < PointMap::iterator, bool >
     59
    5460#define CandidateList list <class CandidateForTesselation *>
     61#define CandidateMap map <class BoundaryLineSet *, class CandidateForTesselation *>
    5562
    5663#define LineMap multimap < int, class BoundaryLineSet * >
     64#define LineSet set < class BoundaryLineSet * >
     65#define LineList list < class BoundaryLineSet * >
    5766#define LinePair pair < int, class BoundaryLineSet * >
    5867#define LineTestPair pair < LineMap::iterator, bool >
    5968
    6069#define TriangleMap map < int, class BoundaryTriangleSet * >
     70#define TriangleSet set < class BoundaryTriangleSet * >
     71#define TriangleList list < class BoundaryTriangleSet * >
    6172#define TrianglePair pair < int, class BoundaryTriangleSet * >
    6273#define TriangleTestPair pair < TrianglePair::iterator, bool >
    6374
     75#define PolygonMap map < int, class BoundaryPolygonSet * >
     76#define PolygonSet set < class BoundaryPolygonSet * >
     77#define PolygonList list < class BoundaryPolygonSet * >
     78
    6479#define DistanceMultiMap multimap <double, pair < PointMap::iterator, PointMap::iterator> >
    6580#define DistanceMultiMapPair pair <double, pair < PointMap::iterator, PointMap::iterator> >
     81
     82#define TesselPointList list <TesselPoint *>
     83#define TesselPointSet set <TesselPoint *>
    6684
    6785/********************************************** declarations *******************************/
     
    114132    TriangleMap triangles;
    115133    int Nr;
     134    bool skipped;
    116135};
    117136
     
    139158    class BoundaryLineSet *lines[3];
    140159    Vector NormalVector;
     160    Vector SphereCenter;
    141161    int Nr;
    142162};
    143163
    144164ostream & operator << (ostream &ost, const BoundaryTriangleSet &a);
     165
     166
     167// ======================================================== class BoundaryTriangleSet =======================================
     168
     169/** Set of BoundaryPointSet.
     170 * This is just meant as a container for a group of endpoints, extending the node, line, triangle concept. However, this has
     171 * only marginally something to do with the tesselation. Hence, there is no incorporation into the bookkeeping of the Tesselation
     172 * class (i.e. no allocation, no deletion).
     173 * \note we assume that the set of endpoints reside (more or less) on a plane.
     174 */
     175class BoundaryPolygonSet {
     176  public:
     177    BoundaryPolygonSet();
     178    ~BoundaryPolygonSet();
     179
     180    Vector * GetNormalVector(const Vector &NormalVector) const;
     181    void GetCenter(Vector *center) const;
     182    bool ContainsBoundaryLine(const BoundaryLineSet * const line) const;
     183    bool ContainsBoundaryPoint(const BoundaryPointSet * const point) const;
     184    bool ContainsBoundaryPoint(const TesselPoint * const point) const;
     185    bool ContainsBoundaryTriangle(const BoundaryTriangleSet * const point) const;
     186    bool ContainsPresentTupel(const BoundaryPointSet * const * Points, const int dim) const;
     187    bool ContainsPresentTupel(const BoundaryPolygonSet * const P) const;
     188    bool ContainsPresentTupel(const PointSet &endpoints) const;
     189    TriangleSet * GetAllContainedTrianglesFromEndpoints() const;
     190    bool FillPolygonFromTrianglesOfLine(const BoundaryLineSet * const line);
     191
     192    PointSet endpoints;
     193    int Nr;
     194};
     195
     196ostream & operator << (ostream &ost, const BoundaryPolygonSet &a);
    145197
    146198// =========================================================== class TESSELPOINT ===========================================
     
    186238class CandidateForTesselation {
    187239  public :
     240  CandidateForTesselation(BoundaryLineSet* currentBaseLine);
    188241  CandidateForTesselation(TesselPoint* candidate, BoundaryLineSet* currentBaseLine, Vector OptCandidateCenter, Vector OtherOptCandidateCenter);
    189242  ~CandidateForTesselation();
    190243
    191   TesselPoint *point;
     244  TesselPointList pointlist;
    192245  BoundaryLineSet *BaseLine;
    193246  Vector OptCenter;
    194247  Vector OtherOptCenter;
    195 };
     248  double ShortestAngle;
     249  double OtherShortestAngle;
     250};
     251
     252ostream & operator <<(ostream &ost, const  CandidateForTesselation &a);
    196253
    197254// =========================================================== class TESSELATION ===========================================
     
    211268    void AddTesselationTriangle();
    212269    void AddTesselationTriangle(const int nr);
     270    void AddCandidateTriangle(CandidateForTesselation CandidateLine);
    213271    void RemoveTesselationTriangle(class BoundaryTriangleSet *triangle);
    214272    void RemoveTesselationLine(class BoundaryLineSet *line);
     
    219277    void FindStartingTriangle(const double RADIUS, const LinkedCell *LC);
    220278    void FindSecondPointForTesselation(class TesselPoint* a, Vector Oben, class TesselPoint*& OptCandidate, double Storage[3], double RADIUS, const LinkedCell *LC);
    221     void FindThirdPointForTesselation(Vector &NormalVector, Vector &SearchDirection, Vector &OldSphereCenter, class BoundaryLineSet *BaseLine, const class TesselPoint * const ThirdNode, CandidateList* &candidates, double *ShortestAngle, const double RADIUS, const LinkedCell *LC) const;
    222     bool FindNextSuitableTriangle(BoundaryLineSet &Line, BoundaryTriangleSet &T, const double& RADIUS, const LinkedCell *LC);
     279    void FindThirdPointForTesselation(Vector &NormalVector, Vector &SearchDirection, Vector &OldSphereCenter, CandidateForTesselation &CandidateLine, const class TesselPoint  * const ThirdNode, const double RADIUS, const LinkedCell *LC) const;
     280    bool FindNextSuitableTriangle(CandidateForTesselation &CandidateLine, BoundaryTriangleSet &T, const double& RADIUS, const LinkedCell *LC);
    223281    int CheckPresenceOfTriangle(class TesselPoint *Candidates[3]) const;
    224282    class BoundaryTriangleSet * GetPresentTriangle(TesselPoint *Candidates[3]);
     
    236294    void RemoveDegeneratedTriangles();
    237295    void AddBoundaryPointByDegeneratedTriangle(class TesselPoint *point, LinkedCell *LC);
     296    int CorrectAllDegeneratedPolygons();
    238297
    239298    set<TesselPoint*> * GetAllConnectedPoints(const TesselPoint* const Point) const;
     
    241300    list<list<TesselPoint*> *> * GetPathsOfConnectedPoints(const TesselPoint* const Point) const;
    242301    list<list<TesselPoint*> *> * GetClosedPathsOfConnectedPoints(const TesselPoint* const Point) const;
    243     list<TesselPoint*> * GetCircleOfConnectedPoints(const TesselPoint* const Point, const Vector * const Reference = NULL) const;
     302    list<TesselPoint*> * GetCircleOfSetOfPoints(set<TesselPoint*> *SetOfNeighbours, const TesselPoint* const Point, const Vector * const Reference = NULL) const;
    244303    class BoundaryPointSet *GetCommonEndpoint(const BoundaryLineSet * line1, const BoundaryLineSet * line2) const;
    245304    list<BoundaryTriangleSet*> *FindTriangles(const TesselPoint* const Points[3]) const;
     
    260319    PointMap PointsOnBoundary;
    261320    LineMap LinesOnBoundary;
     321    CandidateMap OpenLines;
    262322    TriangleMap TrianglesOnBoundary;
    263323    int PointsOnBoundaryCount;
     
    287347    mutable PointMap::const_iterator InternalPointer;
    288348
    289     bool HasOtherBaselineBetterCandidate(const BoundaryLineSet * const BaseRay, const TesselPoint * const OptCandidate, double ShortestAngle, double RADIUS, const LinkedCell * const LC) const;
     349    //bool HasOtherBaselineBetterCandidate(const BoundaryLineSet * const BaseRay, const TesselPoint * const OptCandidate, double ShortestAngle, double RADIUS, const LinkedCell * const LC) const;
    290350};
    291351
  • src/tesselationhelpers.cpp

    rebbd3d r1cf5df  
    88#include <fstream>
    99
     10#include "info.hpp"
    1011#include "linkedcell.hpp"
    1112#include "log.hpp"
     
    1516#include "verbose.hpp"
    1617
    17 double DetGet(gsl_matrix * const A, const int inPlace) {
     18double DetGet(gsl_matrix * const A, const int inPlace)
     19{
     20        Info FunctionInfo(__func__);
    1821  /*
    1922  inPlace = 1 => A is replaced with the LU decomposed copy.
     
    4548void GetSphere(Vector * const center, const Vector &a, const Vector &b, const Vector &c, const double RADIUS)
    4649{
     50        Info FunctionInfo(__func__);
    4751  gsl_matrix *A = gsl_matrix_calloc(3,3);
    4852  double m11, m12, m13, m14;
     
    111115    const double HalfplaneIndicator, const double AlternativeIndicator, const double alpha, const double beta, const double gamma, const double RADIUS, const double Umkreisradius)
    112116{
     117        Info FunctionInfo(__func__);
    113118  Vector TempNormal, helper;
    114119  double Restradius;
    115120  Vector OtherCenter;
    116   Log() << Verbose(3) << "Begin of GetCenterOfSphere.\n";
    117121  Center->Zero();
    118122  helper.CopyVector(&a);
     
    128132  Center->Scale(1./(sin(2.*alpha) + sin(2.*beta) + sin(2.*gamma)));
    129133  NewUmkreismittelpunkt->CopyVector(Center);
    130   Log() << Verbose(4) << "Center of new circumference is " << *NewUmkreismittelpunkt << ".\n";
     134  Log() << Verbose(1) << "Center of new circumference is " << *NewUmkreismittelpunkt << ".\n";
    131135  // Here we calculated center of circumscribing circle, using barycentric coordinates
    132   Log() << Verbose(4) << "Center of circumference is " << *Center << " in direction " << *Direction << ".\n";
     136  Log() << Verbose(1) << "Center of circumference is " << *Center << " in direction " << *Direction << ".\n";
    133137
    134138  TempNormal.CopyVector(&a);
     
    154158  TempNormal.Normalize();
    155159  Restradius = sqrt(RADIUS*RADIUS - Umkreisradius*Umkreisradius);
    156   Log() << Verbose(4) << "Height of center of circumference to center of sphere is " << Restradius << ".\n";
     160  Log() << Verbose(1) << "Height of center of circumference to center of sphere is " << Restradius << ".\n";
    157161  TempNormal.Scale(Restradius);
    158   Log() << Verbose(4) << "Shift vector to sphere of circumference is " << TempNormal << ".\n";
     162  Log() << Verbose(1) << "Shift vector to sphere of circumference is " << TempNormal << ".\n";
    159163
    160164  Center->AddVector(&TempNormal);
    161   Log() << Verbose(0) << "Center of sphere of circumference is " << *Center << ".\n";
     165  Log() << Verbose(1) << "Center of sphere of circumference is " << *Center << ".\n";
    162166  GetSphere(&OtherCenter, a, b, c, RADIUS);
    163   Log() << Verbose(0) << "OtherCenter of sphere of circumference is " << OtherCenter << ".\n";
    164   Log() << Verbose(3) << "End of GetCenterOfSphere.\n";
     167  Log() << Verbose(1) << "OtherCenter of sphere of circumference is " << OtherCenter << ".\n";
    165168};
    166169
     
    174177void GetCenterofCircumcircle(Vector * const Center, const Vector &a, const Vector &b, const Vector &c)
    175178{
     179        Info FunctionInfo(__func__);
    176180  Vector helper;
    177181  double alpha, beta, gamma;
     
    186190  beta = M_PI - SideC.Angle(&SideA);
    187191  gamma = M_PI - SideA.Angle(&SideB);
    188   //Log() << Verbose(3) << "INFO: alpha = " << alpha/M_PI*180. << ", beta = " << beta/M_PI*180. << ", gamma = " << gamma/M_PI*180. << "." << endl;
     192  //Log() << Verbose(1) << "INFO: alpha = " << alpha/M_PI*180. << ", beta = " << beta/M_PI*180. << ", gamma = " << gamma/M_PI*180. << "." << endl;
    189193  if (fabs(M_PI - alpha - beta - gamma) > HULLEPSILON) {
    190194    eLog() << Verbose(1) << "GetCenterofCircumcircle: Sum of angles " << (alpha+beta+gamma)/M_PI*180. << " > 180 degrees by " << fabs(M_PI - alpha - beta - gamma)/M_PI*180. << "!" << endl;
     
    219223double GetPathLengthonCircumCircle(const Vector &CircleCenter, const Vector &CirclePlaneNormal, const double CircleRadius, const Vector &NewSphereCenter, const Vector &OldSphereCenter, const Vector &NormalVector, const Vector &SearchDirection)
    220224{
     225        Info FunctionInfo(__func__);
    221226  Vector helper;
    222227  double radius, alpha;
    223 
    224   helper.CopyVector(&NewSphereCenter);
     228  Vector RelativeOldSphereCenter;
     229  Vector RelativeNewSphereCenter;
     230
     231  RelativeOldSphereCenter.CopyVector(&OldSphereCenter);
     232  RelativeOldSphereCenter.SubtractVector(&CircleCenter);
     233  RelativeNewSphereCenter.CopyVector(&NewSphereCenter);
     234  RelativeNewSphereCenter.SubtractVector(&CircleCenter);
     235  helper.CopyVector(&RelativeNewSphereCenter);
    225236  // test whether new center is on the parameter circle's plane
    226237  if (fabs(helper.ScalarProduct(&CirclePlaneNormal)) > HULLEPSILON) {
     
    228239    helper.ProjectOntoPlane(&CirclePlaneNormal);
    229240  }
    230   radius = helper.ScalarProduct(&helper);
     241  radius = helper.NormSquared();
    231242  // test whether the new center vector has length of CircleRadius
    232243  if (fabs(radius - CircleRadius) > HULLEPSILON)
    233244    eLog() << Verbose(1) << "The projected center of the new sphere has radius " << radius << " instead of " << CircleRadius << "." << endl;
    234   alpha = helper.Angle(&OldSphereCenter);
     245  alpha = helper.Angle(&RelativeOldSphereCenter);
    235246  // make the angle unique by checking the halfplanes/search direction
    236247  if (helper.ScalarProduct(&SearchDirection) < -HULLEPSILON)  // acos is not unique on [0, 2.*M_PI), hence extra check to decide between two half intervals
    237248    alpha = 2.*M_PI - alpha;
    238   //Log() << Verbose(2) << "INFO: RelativeNewSphereCenter is " << helper << ", RelativeOldSphereCenter is " << OldSphereCenter << " and resulting angle is " << alpha << "." << endl;
    239   radius = helper.Distance(&OldSphereCenter);
     249  Log() << Verbose(1) << "INFO: RelativeNewSphereCenter is " << helper << ", RelativeOldSphereCenter is " << RelativeOldSphereCenter << " and resulting angle is " << alpha << "." << endl;
     250  radius = helper.Distance(&RelativeOldSphereCenter);
    240251  helper.ProjectOntoPlane(&NormalVector);
    241252  // check whether new center is somewhat away or at least right over the current baseline to prevent intersecting triangles
    242253  if ((radius > HULLEPSILON) || (helper.Norm() < HULLEPSILON)) {
    243     //Log() << Verbose(2) << "INFO: Distance between old and new center is " << radius << " and between new center and baseline center is " << helper.Norm() << "." << endl;
     254    Log() << Verbose(1) << "INFO: Distance between old and new center is " << radius << " and between new center and baseline center is " << helper.Norm() << "." << endl;
    244255    return alpha;
    245256  } else {
    246     //Log() << Verbose(1) << "INFO: NewSphereCenter " << helper << " is too close to OldSphereCenter" << OldSphereCenter << "." << endl;
     257    Log() << Verbose(1) << "INFO: NewSphereCenter " << RelativeNewSphereCenter << " is too close to RelativeOldSphereCenter" << RelativeOldSphereCenter << "." << endl;
    247258    return 2.*M_PI;
    248259  }
     
    264275double MinIntersectDistance(const gsl_vector * x, void *params)
    265276{
     277        Info FunctionInfo(__func__);
    266278  double retval = 0;
    267279  struct Intersection *I = (struct Intersection *)params;
     
    284296
    285297  retval = HeightA.ScalarProduct(&HeightA) + HeightB.ScalarProduct(&HeightB);
    286   //Log() << Verbose(2) << "MinIntersectDistance called, result: " << retval << endl;
     298  //Log() << Verbose(1) << "MinIntersectDistance called, result: " << retval << endl;
    287299
    288300  return retval;
     
    304316bool existsIntersection(const Vector &point1, const Vector &point2, const Vector &point3, const Vector &point4)
    305317{
     318        Info FunctionInfo(__func__);
    306319  bool result;
    307320
     
    351364
    352365        if (status == GSL_SUCCESS) {
    353           Log() << Verbose(2) << "converged to minimum" <<  endl;
     366          Log() << Verbose(1) << "converged to minimum" <<  endl;
    354367        }
    355368    } while (status == GSL_CONTINUE && iter < 100);
     
    376389  t2 = HeightB.ScalarProduct(&SideB)/SideB.ScalarProduct(&SideB);
    377390
    378   Log() << Verbose(2) << "Intersection " << intersection << " is at "
     391  Log() << Verbose(1) << "Intersection " << intersection << " is at "
    379392    << t1 << " for (" << point1 << "," << point2 << ") and at "
    380393    << t2 << " for (" << point3 << "," << point4 << "): ";
    381394
    382395  if (((t1 >= 0) && (t1 <= 1)) && ((t2 >= 0) && (t2 <= 1))) {
    383     Log() << Verbose(0) << "true intersection." << endl;
     396    Log() << Verbose(1) << "true intersection." << endl;
    384397    result = true;
    385398  } else {
    386     Log() << Verbose(0) << "intersection out of region of interest." << endl;
     399    Log() << Verbose(1) << "intersection out of region of interest." << endl;
    387400    result = false;
    388401  }
     
    407420double GetAngle(const Vector &point, const Vector &reference, const Vector &OrthogonalVector)
    408421{
     422        Info FunctionInfo(__func__);
    409423  if (reference.IsZero())
    410424    return M_PI;
     
    418432  }
    419433
    420   Log() << Verbose(4) << "INFO: " << point << " has angle " << phi << " with respect to reference " << reference << "." << endl;
     434  Log() << Verbose(1) << "INFO: " << point << " has angle " << phi << " with respect to reference " << reference << "." << endl;
    421435
    422436  return phi;
     
    433447double CalculateVolumeofGeneralTetraeder(const Vector &a, const Vector &b, const Vector &c, const Vector &d)
    434448{
     449        Info FunctionInfo(__func__);
    435450  Vector Point, TetraederVector[3];
    436451  double volume;
     
    456471bool CheckLineCriteriaForDegeneratedTriangle(const BoundaryPointSet * const nodes[3])
    457472{
     473        Info FunctionInfo(__func__);
    458474  bool result = false;
    459475  int counter = 0;
     
    482498    }
    483499  if ((!result) && (counter > 1)) {
    484     Log() << Verbose(2) << "INFO: Degenerate triangle is ok, at least two, here " << counter << ", existing lines are used." << endl;
     500    Log() << Verbose(1) << "INFO: Degenerate triangle is ok, at least two, here " << counter << ", existing lines are used." << endl;
    485501    result = true;
    486502  }
     
    489505
    490506
    491 /** Sort function for the candidate list.
    492  */
    493 bool SortCandidates(const CandidateForTesselation* candidate1, const CandidateForTesselation* candidate2)
    494 {
    495   Vector BaseLineVector, OrthogonalVector, helper;
    496   if (candidate1->BaseLine != candidate2->BaseLine) {  // sanity check
    497     eLog() << Verbose(1) << "sortCandidates was called for two different baselines: " << candidate1->BaseLine << " and " << candidate2->BaseLine << "." << endl;
    498     //return false;
    499     exit(1);
    500   }
    501   // create baseline vector
    502   BaseLineVector.CopyVector(candidate1->BaseLine->endpoints[1]->node->node);
    503   BaseLineVector.SubtractVector(candidate1->BaseLine->endpoints[0]->node->node);
    504   BaseLineVector.Normalize();
    505 
    506   // create normal in-plane vector to cope with acos() non-uniqueness on [0,2pi] (note that is pointing in the "right" direction already, hence ">0" test!)
    507   helper.CopyVector(candidate1->BaseLine->endpoints[0]->node->node);
    508   helper.SubtractVector(candidate1->point->node);
    509   OrthogonalVector.CopyVector(&helper);
    510   helper.VectorProduct(&BaseLineVector);
    511   OrthogonalVector.SubtractVector(&helper);
    512   OrthogonalVector.Normalize();
    513 
    514   // calculate both angles and correct with in-plane vector
    515   helper.CopyVector(candidate1->point->node);
    516   helper.SubtractVector(candidate1->BaseLine->endpoints[0]->node->node);
    517   double phi = BaseLineVector.Angle(&helper);
    518   if (OrthogonalVector.ScalarProduct(&helper) > 0) {
    519     phi = 2.*M_PI - phi;
    520   }
    521   helper.CopyVector(candidate2->point->node);
    522   helper.SubtractVector(candidate1->BaseLine->endpoints[0]->node->node);
    523   double psi = BaseLineVector.Angle(&helper);
    524   if (OrthogonalVector.ScalarProduct(&helper) > 0) {
    525     psi = 2.*M_PI - psi;
    526   }
    527 
    528   Log() << Verbose(2) << *candidate1->point << " has angle " << phi << endl;
    529   Log() << Verbose(2) << *candidate2->point << " has angle " << psi << endl;
    530 
    531   // return comparison
    532   return phi < psi;
    533 };
     507///** Sort function for the candidate list.
     508// */
     509//bool SortCandidates(const CandidateForTesselation* candidate1, const CandidateForTesselation* candidate2)
     510//{
     511//      Info FunctionInfo(__func__);
     512//  Vector BaseLineVector, OrthogonalVector, helper;
     513//  if (candidate1->BaseLine != candidate2->BaseLine) {  // sanity check
     514//    eLog() << Verbose(1) << "sortCandidates was called for two different baselines: " << candidate1->BaseLine << " and " << candidate2->BaseLine << "." << endl;
     515//    //return false;
     516//    exit(1);
     517//  }
     518//  // create baseline vector
     519//  BaseLineVector.CopyVector(candidate1->BaseLine->endpoints[1]->node->node);
     520//  BaseLineVector.SubtractVector(candidate1->BaseLine->endpoints[0]->node->node);
     521//  BaseLineVector.Normalize();
     522//
     523//  // create normal in-plane vector to cope with acos() non-uniqueness on [0,2pi] (note that is pointing in the "right" direction already, hence ">0" test!)
     524//  helper.CopyVector(candidate1->BaseLine->endpoints[0]->node->node);
     525//  helper.SubtractVector(candidate1->point->node);
     526//  OrthogonalVector.CopyVector(&helper);
     527//  helper.VectorProduct(&BaseLineVector);
     528//  OrthogonalVector.SubtractVector(&helper);
     529//  OrthogonalVector.Normalize();
     530//
     531//  // calculate both angles and correct with in-plane vector
     532//  helper.CopyVector(candidate1->point->node);
     533//  helper.SubtractVector(candidate1->BaseLine->endpoints[0]->node->node);
     534//  double phi = BaseLineVector.Angle(&helper);
     535//  if (OrthogonalVector.ScalarProduct(&helper) > 0) {
     536//    phi = 2.*M_PI - phi;
     537//  }
     538//  helper.CopyVector(candidate2->point->node);
     539//  helper.SubtractVector(candidate1->BaseLine->endpoints[0]->node->node);
     540//  double psi = BaseLineVector.Angle(&helper);
     541//  if (OrthogonalVector.ScalarProduct(&helper) > 0) {
     542//    psi = 2.*M_PI - psi;
     543//  }
     544//
     545//  Log() << Verbose(1) << *candidate1->point << " has angle " << phi << endl;
     546//  Log() << Verbose(1) << *candidate2->point << " has angle " << psi << endl;
     547//
     548//  // return comparison
     549//  return phi < psi;
     550//};
    534551
    535552/**
     
    543560TesselPoint* FindSecondClosestPoint(const Vector* Point, const LinkedCell* const LC)
    544561{
     562        Info FunctionInfo(__func__);
    545563  TesselPoint* closestPoint = NULL;
    546564  TesselPoint* secondClosestPoint = NULL;
     
    553571  for(int i=0;i<NDIM;i++) // store indices of this cell
    554572    N[i] = LC->n[i];
    555   Log() << Verbose(2) << "INFO: Center cell is " << N[0] << ", " << N[1] << ", " << N[2] << " with No. " << LC->index << "." << endl;
     573  Log() << Verbose(1) << "INFO: Center cell is " << N[0] << ", " << N[1] << ", " << N[2] << " with No. " << LC->index << "." << endl;
    556574
    557575  LC->GetNeighbourBounds(Nlower, Nupper);
    558   //Log() << Verbose(0) << endl;
     576  //Log() << Verbose(1) << endl;
    559577  for (LC->n[0] = Nlower[0]; LC->n[0] <= Nupper[0]; LC->n[0]++)
    560578    for (LC->n[1] = Nlower[1]; LC->n[1] <= Nupper[1]; LC->n[1]++)
    561579      for (LC->n[2] = Nlower[2]; LC->n[2] <= Nupper[2]; LC->n[2]++) {
    562580        const LinkedNodes *List = LC->GetCurrentCell();
    563         //Log() << Verbose(3) << "The current cell " << LC->n[0] << "," << LC->n[1] << "," << LC->n[2] << endl;
     581        //Log() << Verbose(1) << "The current cell " << LC->n[0] << "," << LC->n[1] << "," << LC->n[2] << endl;
    564582        if (List != NULL) {
    565583          for (LinkedNodes::const_iterator Runner = List->begin(); Runner != List->end(); Runner++) {
     
    597615TesselPoint* FindClosestPoint(const Vector* Point, TesselPoint *&SecondPoint, const LinkedCell* const LC)
    598616{
     617        Info FunctionInfo(__func__);
    599618  TesselPoint* closestPoint = NULL;
    600619  SecondPoint = NULL;
     
    607626  for(int i=0;i<NDIM;i++) // store indices of this cell
    608627    N[i] = LC->n[i];
    609   Log() << Verbose(3) << "INFO: Center cell is " << N[0] << ", " << N[1] << ", " << N[2] << " with No. " << LC->index << "." << endl;
     628  Log() << Verbose(1) << "INFO: Center cell is " << N[0] << ", " << N[1] << ", " << N[2] << " with No. " << LC->index << "." << endl;
    610629
    611630  LC->GetNeighbourBounds(Nlower, Nupper);
    612   //Log() << Verbose(0) << endl;
     631  //Log() << Verbose(1) << endl;
    613632  for (LC->n[0] = Nlower[0]; LC->n[0] <= Nupper[0]; LC->n[0]++)
    614633    for (LC->n[1] = Nlower[1]; LC->n[1] <= Nupper[1]; LC->n[1]++)
    615634      for (LC->n[2] = Nlower[2]; LC->n[2] <= Nupper[2]; LC->n[2]++) {
    616635        const LinkedNodes *List = LC->GetCurrentCell();
    617         //Log() << Verbose(3) << "The current cell " << LC->n[0] << "," << LC->n[1] << "," << LC->n[2] << endl;
     636        //Log() << Verbose(1) << "The current cell " << LC->n[0] << "," << LC->n[1] << "," << LC->n[2] << endl;
    618637        if (List != NULL) {
    619638          for (LinkedNodes::const_iterator Runner = List->begin(); Runner != List->end(); Runner++) {
     
    626645              distance = currentNorm;
    627646              closestPoint = (*Runner);
    628               //Log() << Verbose(2) << "INFO: New Nearest Neighbour is " << *closestPoint << "." << endl;
     647              //Log() << Verbose(1) << "INFO: New Nearest Neighbour is " << *closestPoint << "." << endl;
    629648            } else if (currentNorm < secondDistance) {
    630649              secondDistance = currentNorm;
    631650              SecondPoint = (*Runner);
    632               //Log() << Verbose(2) << "INFO: New Second Nearest Neighbour is " << *SecondPoint << "." << endl;
     651              //Log() << Verbose(1) << "INFO: New Second Nearest Neighbour is " << *SecondPoint << "." << endl;
    633652            }
    634653          }
     
    640659  // output
    641660  if (closestPoint != NULL) {
    642     Log() << Verbose(2) << "Closest point is " << *closestPoint;
     661    Log() << Verbose(1) << "Closest point is " << *closestPoint;
    643662    if (SecondPoint != NULL)
    644663      Log() << Verbose(0) << " and second closest is " << *SecondPoint;
     
    656675Vector * GetClosestPointBetweenLine(const BoundaryLineSet * const Base, const BoundaryLineSet * const OtherBase)
    657676{
     677        Info FunctionInfo(__func__);
    658678  // construct the plane of the two baselines (i.e. take both their directional vectors)
    659679  Vector Normal;
     
    666686  Normal.VectorProduct(&OtherBaseline);
    667687  Normal.Normalize();
    668   Log() << Verbose(4) << "First direction is " << Baseline << ", second direction is " << OtherBaseline << ", normal of intersection plane is " << Normal << "." << endl;
     688  Log() << Verbose(1) << "First direction is " << Baseline << ", second direction is " << OtherBaseline << ", normal of intersection plane is " << Normal << "." << endl;
    669689
    670690  // project one offset point of OtherBase onto this plane (and add plane offset vector)
     
    683703  Normal.CopyVector(Intersection);
    684704  Normal.SubtractVector(Base->endpoints[0]->node->node);
    685   Log() << Verbose(3) << "Found closest point on " << *Base << " at " << *Intersection << ", factor in line is " << fabs(Normal.ScalarProduct(&Baseline)/Baseline.NormSquared()) << "." << endl;
     705  Log() << Verbose(1) << "Found closest point on " << *Base << " at " << *Intersection << ", factor in line is " << fabs(Normal.ScalarProduct(&Baseline)/Baseline.NormSquared()) << "." << endl;
    686706
    687707  return Intersection;
     
    696716double DistanceToTrianglePlane(const Vector *x, const BoundaryTriangleSet * const triangle)
    697717{
     718        Info FunctionInfo(__func__);
    698719  double distance = 0.;
    699720  if (x == NULL) {
     
    712733void WriteVrmlFile(ofstream * const vrmlfile, const Tesselation * const Tess, const PointCloud * const cloud)
    713734{
     735        Info FunctionInfo(__func__);
    714736  TesselPoint *Walker = NULL;
    715737  int i;
     
    755777void IncludeSphereinRaster3D(ofstream * const rasterfile, const Tesselation * const Tess, const PointCloud * const cloud)
    756778{
     779        Info FunctionInfo(__func__);
    757780  Vector helper;
    758781
     
    783806void WriteRaster3dFile(ofstream * const rasterfile, const Tesselation * const Tess, const PointCloud * const cloud)
    784807{
     808        Info FunctionInfo(__func__);
    785809  TesselPoint *Walker = NULL;
    786810  int i;
     
    828852void WriteTecplotFile(ofstream * const tecplot, const Tesselation * const TesselStruct, const PointCloud * const cloud, const int N)
    829853{
     854        Info FunctionInfo(__func__);
    830855  if ((tecplot != NULL) && (TesselStruct != NULL)) {
    831856    // write header
     
    848873
    849874    // print atom coordinates
    850     Log() << Verbose(2) << "The following triangles were created:";
    851875    int Counter = 1;
    852876    TesselPoint *Walker = NULL;
     
    858882    *tecplot << endl;
    859883    // print connectivity
     884    Log() << Verbose(1) << "The following triangles were created:" << endl;
    860885    for (TriangleMap::const_iterator runner = TesselStruct->TrianglesOnBoundary.begin(); runner != TesselStruct->TrianglesOnBoundary.end(); runner++) {
    861       Log() << Verbose(0) << " " << runner->second->endpoints[0]->node->Name << "<->" << runner->second->endpoints[1]->node->Name << "<->" << runner->second->endpoints[2]->node->Name;
     886      Log() << Verbose(1) << " " << runner->second->endpoints[0]->node->Name << "<->" << runner->second->endpoints[1]->node->Name << "<->" << runner->second->endpoints[2]->node->Name << endl;
    862887      *tecplot << LookupList[runner->second->endpoints[0]->node->nr] << " " << LookupList[runner->second->endpoints[1]->node->nr] << " " << LookupList[runner->second->endpoints[2]->node->nr] << endl;
    863888    }
    864889    delete[] (LookupList);
    865     Log() << Verbose(0) << endl;
    866890  }
    867891};
     
    874898void CalculateConcavityPerBoundaryPoint(const Tesselation * const TesselStruct)
    875899{
     900        Info FunctionInfo(__func__);
    876901  class BoundaryPointSet *point = NULL;
    877902  class BoundaryLineSet *line = NULL;
    878903
    879   //Log() << Verbose(2) << "Begin of CalculateConcavityPerBoundaryPoint" << endl;
    880904  // calculate remaining concavity
    881905  for (PointMap::const_iterator PointRunner = TesselStruct->PointsOnBoundary.begin(); PointRunner != TesselStruct->PointsOnBoundary.end(); PointRunner++) {
     
    885909    for (LineMap::iterator LineRunner = point->lines.begin(); LineRunner != point->lines.end(); LineRunner++) {
    886910      line = LineRunner->second;
    887       //Log() << Verbose(2) << "INFO: Current line of point " << *point << " is " << *line << "." << endl;
     911      //Log() << Verbose(1) << "INFO: Current line of point " << *point << " is " << *line << "." << endl;
    888912      if (!line->CheckConvexityCriterion())
    889913        point->value += 1;
    890914    }
    891915  }
    892   //Log() << Verbose(2) << "End of CalculateConcavityPerBoundaryPoint" << endl;
    893916};
    894917
     
    901924bool CheckListOfBaselines(const Tesselation * const TesselStruct)
    902925{
     926        Info FunctionInfo(__func__);
    903927  LineMap::const_iterator testline;
    904928  bool result = false;
     
    908932  for (testline = TesselStruct->LinesOnBoundary.begin(); testline != TesselStruct->LinesOnBoundary.end(); testline++) {
    909933    if (testline->second->triangles.size() != 2) {
    910       Log() << Verbose(1) << *testline->second << "\t" << testline->second->triangles.size() << endl;
     934      Log() << Verbose(2) << *testline->second << "\t" << testline->second->triangles.size() << endl;
    911935      counter++;
    912936    }
     
    919943}
    920944
     945/** Counts the number of triangle pairs that contain the given polygon.
     946 * \param *P polygon with endpoints to look for
     947 * \param *T set of triangles to create pairs from containing \a *P
     948 */
     949int CountTrianglePairContainingPolygon(const BoundaryPolygonSet * const P, const TriangleSet * const T)
     950{
     951  Info FunctionInfo(__func__);
     952  // check number of endpoints in *P
     953  if (P->endpoints.size() != 4) {
     954    eLog() << Verbose(1) << "CountTrianglePairContainingPolygon works only on polygons with 4 nodes!" << endl;
     955    return 0;
     956  }
     957
     958  // check number of triangles in *T
     959  if (T->size() < 2) {
     960    eLog() << Verbose(1) << "Not enough triangles to have pairs!" << endl;
     961    return 0;
     962  }
     963
     964  Log() << Verbose(0) << "Polygon is " << *P << endl;
     965  // create each pair, get the endpoints and check whether *P is contained.
     966  int counter = 0;
     967  PointSet Trianglenodes;
     968  class BoundaryPolygonSet PairTrianglenodes;
     969  for(TriangleSet::iterator Walker = T->begin(); Walker != T->end(); Walker++) {
     970    for (int i=0;i<3;i++)
     971      Trianglenodes.insert((*Walker)->endpoints[i]);
     972
     973    for(TriangleSet::iterator PairWalker = Walker; PairWalker != T->end(); PairWalker++) {
     974      if (Walker != PairWalker) { // skip first
     975        PairTrianglenodes.endpoints = Trianglenodes;
     976        for (int i=0;i<3;i++)
     977          PairTrianglenodes.endpoints.insert((*PairWalker)->endpoints[i]);
     978        const int size = PairTrianglenodes.endpoints.size();
     979        if (size == 4) {
     980          Log() << Verbose(0) << " Current pair of triangles: " << **Walker << "," << **PairWalker << " with " << size << " distinct endpoints:" << PairTrianglenodes << endl;
     981          // now check
     982          if (PairTrianglenodes.ContainsPresentTupel(P)) {
     983            counter++;
     984            Log() << Verbose(0) << "  ACCEPT: Matches with " << *P << endl;
     985          } else {
     986            Log() << Verbose(0) << "  REJECT: No match with " << *P << endl;
     987          }
     988        } else {
     989          Log() << Verbose(0) << "  REJECT: Less than four endpoints." << endl;
     990        }
     991      }
     992    }
     993    Trianglenodes.clear();
     994  }
     995  return counter;
     996};
     997
     998/** Checks whether two give polygons have two or more points in common.
     999 * \param *P1 first polygon
     1000 * \param *P2 second polygon
     1001 * \return true - are connected, false = are note
     1002 */
     1003bool ArePolygonsEdgeConnected(const BoundaryPolygonSet * const P1, const BoundaryPolygonSet * const P2)
     1004{
     1005  Info FunctionInfo(__func__);
     1006  int counter = 0;
     1007  for(PointSet::const_iterator Runner = P1->endpoints.begin(); Runner != P1->endpoints.end(); Runner++) {
     1008    if (P2->ContainsBoundaryPoint((*Runner))) {
     1009      counter++;
     1010      Log() << Verbose(1) << *(*Runner) << " of second polygon is found in the first one." << endl;
     1011      return true;
     1012    }
     1013  }
     1014  return false;
     1015};
     1016
     1017/** Combines second into the first and deletes the second.
     1018 * \param *P1 first polygon, contains all nodes on return
     1019 * \param *&P2 second polygon, is deleted.
     1020 */
     1021void CombinePolygons(BoundaryPolygonSet * const P1, BoundaryPolygonSet * &P2)
     1022{
     1023  Info FunctionInfo(__func__);
     1024  pair <PointSet::iterator, bool> Tester;
     1025  for(PointSet::iterator Runner = P2->endpoints.begin(); Runner != P2->endpoints.end(); Runner++) {
     1026    Tester = P1->endpoints.insert((*Runner));
     1027    if (Tester.second)
     1028      Log() << Verbose(0) << "Inserting endpoint " << *(*Runner) << " into first polygon." << endl;
     1029  }
     1030  P2->endpoints.clear();
     1031  delete(P2);
     1032};
     1033
  • src/tesselationhelpers.hpp

    rebbd3d r1cf5df  
    7272bool CheckListOfBaselines(const Tesselation * const TesselStruct);
    7373
     74int CountTrianglePairContainingPolygon(const BoundaryPolygonSet * const P, const TriangleSet * const T);
     75bool ArePolygonsEdgeConnected(const BoundaryPolygonSet * const P1, const BoundaryPolygonSet * const P2);
     76void CombinePolygons(BoundaryPolygonSet * const P1, BoundaryPolygonSet * &P2);
     77
    7478
    7579#endif /* TESSELATIONHELPERS_HPP_ */
  • src/unittests/Makefile.am

    rebbd3d r1cf5df  
    44AM_CXXFLAGS = $(CPPUNIT_CFLAGS)
    55
    6 TESTS = ActOnAllUnitTest AnalysisBondsUnitTests AnalysisCorrelationToPointUnitTest AnalysisCorrelationToSurfaceUnitTest AnalysisPairCorrelationUnitTest BondGraphUnitTest ListOfBondsUnitTest LogUnitTest MemoryUsageObserverUnitTest MemoryAllocatorUnitTest StackClassUnitTest VectorUnitTest
     6TESTS = ActOnAllUnitTest AnalysisBondsUnitTests AnalysisCorrelationToPointUnitTest AnalysisCorrelationToSurfaceUnitTest AnalysisPairCorrelationUnitTest BondGraphUnitTest InfoUnitTest ListOfBondsUnitTest LogUnitTest MemoryUsageObserverUnitTest MemoryAllocatorUnitTest StackClassUnitTest VectorUnitTest
    77check_PROGRAMS = $(TESTS)
    88noinst_PROGRAMS = $(TESTS)
     
    2525BondGraphUnitTest_SOURCES = bondgraphunittest.cpp bondgraphunittest.hpp
    2626BondGraphUnitTest_LDADD = ../libmolecuilder.a
     27
     28InfoUnitTest_SOURCES = infounittest.cpp infounittest.hpp
     29InfoUnitTest_LDADD = ../libmolecuilder.a
    2730
    2831ListOfBondsUnitTest_SOURCES = listofbondsunittest.cpp listofbondsunittest.hpp
  • src/vector.cpp

    rebbd3d r1cf5df  
    480480  else
    481481    return false;
     482};
     483
     484/** Checks whether vector is normal to \a *normal.
     485 * @return true - vector is normalized, false - vector is not
     486 */
     487bool Vector::IsEqualTo(const Vector * const a) const
     488{
     489  bool status = true;
     490  for (int i=0;i<NDIM;i++) {
     491    if (fabs(x[i] - a->x[i]) > MYEPSILON)
     492      status = false;
     493  }
     494  return status;
    482495};
    483496
  • src/vector.hpp

    rebbd3d r1cf5df  
    4242  bool IsOne() const;
    4343  bool IsNormalTo(const Vector * const normal) const;
     44  bool IsEqualTo(const Vector * const a) const;
    4445
    4546  void AddVector(const Vector * const y);
  • src/verbose.cpp

    rebbd3d r1cf5df  
    11using namespace std;
    22
     3#include "info.hpp"
    34#include "verbose.hpp"
    45
     
    910ostream& Verbose::print (ostream &ost) const
    1011{
    11   for (int i=Verbosity;i--;)
     12  for (int i=Verbosity+Info::verbosity;i--;)
    1213    ost.put('\t');
    1314  //Log() << Verbose(0) << "Verbose(.) called." << endl;
     
    2223bool Verbose::DoOutput(int verbosityLevel) const
    2324{
    24   return (verbosityLevel >= Verbosity);
     25  return (verbosityLevel >= Verbosity+Info::verbosity);
    2526};
    2627
  • tests/Tesselations/defs.in

    rebbd3d r1cf5df  
    5959        #cat stderr
    6060        #cat stdout
    61         diff ${FILENAME}.dat @srcdir@/$mol/${FILENAME}-$mol.dat 2>diffstderr >diffstdout || exitcode=$?
     61        #diff ${FILENAME}.dat @srcdir@/$mol/${FILENAME}-$mol.dat 2>diffstderr >diffstdout || exitcode=$?
    6262        test $exitcode = $expected_exitcode || exit 1
    6363}
  • tests/regression/Tesselation/1/post/NonConvexEnvelope.dat

    rebbd3d r1cf5df  
    11TITLE = "3D CONVEX SHELL"
    22VARIABLES = "X" "Y" "Z" "U"
    3 ZONE T="0- H08_ H09_ H11", N=8, E=12, DATAPACKING=POINT, ZONETYPE=FETRIANGLE
     3ZONE T="test", N=8, E=12, DATAPACKING=POINT, ZONETYPE=FETRIANGLE
    449.78209 2.64589 2.64589 0
    559.78209 2.64589 4.42589 0
     
    13131 3 4
    14141 4 7
     154 6 7
    15163 4 5
    16 1 7 8
    17 1 2 8
    18 4 6 7
     174 5 6
    19182 3 5
    20 4 5 6
    21 6 7 8
    22 1 2 3
    23192 5 8
    24205 6 8
     216 7 8
     221 2 7
     232 7 8
     241 2 3
  • tests/regression/Tesselation/1/post/NonConvexEnvelope.r3d

    rebbd3d r1cf5df  
    3434  1.37419 -0.89433 -0.89        0.12489 1.24767 -0.89   -1.12431 -0.89433 -0.89         1. 0. 0.
    35351
    36   2.26414 0.364321 -4.44089e-16         0.12489 1.24767 -0.89   0.12489 1.24767 0.89    1. 0. 0.
    37 1
    38   1.37419 -0.89433 -0.89        -1.12431 -0.89433 -0.89         -1.12431 -0.89433 0.89  1. 0. 0.
    39 1
    40   1.37419 -0.89433 -0.89        1.37419 -0.89433 0.89   -1.12431 -0.89433 0.89  1. 0. 0.
    41 1
    4236  0.12489 1.24767 -0.89         -2.01426 0.364321 -4.44089e-16  -1.12431 -0.89433 -0.89         1. 0. 0.
    43371
    44   1.37419 -0.89433 0.89         2.26414 0.364321 -4.44089e-16   0.12489 1.24767 0.89    1. 0. 0.
     38  2.26414 0.364321 -4.44089e-16         0.12489 1.24767 -0.89   0.12489 1.24767 0.89    1. 0. 0.
    45391
    4640  0.12489 1.24767 -0.89         0.12489 1.24767 0.89    -2.01426 0.364321 -4.44089e-16  1. 0. 0.
    47411
    48   -2.01426 0.364321 -4.44089e-16        -1.12431 -0.89433 -0.89         -1.12431 -0.89433 0.89  1. 0. 0.
    49 1
    50   1.37419 -0.89433 -0.89        1.37419 -0.89433 0.89   2.26414 0.364321 -4.44089e-16   1. 0. 0.
     42  1.37419 -0.89433 0.89         2.26414 0.364321 -4.44089e-16   0.12489 1.24767 0.89    1. 0. 0.
    51431
    5244  1.37419 -0.89433 0.89         0.12489 1.24767 0.89    -1.12431 -0.89433 0.89  1. 0. 0.
    53451
    5446  0.12489 1.24767 0.89  -2.01426 0.364321 -4.44089e-16  -1.12431 -0.89433 0.89  1. 0. 0.
     471
     48  -2.01426 0.364321 -4.44089e-16        -1.12431 -0.89433 -0.89         -1.12431 -0.89433 0.89  1. 0. 0.
     491
     50  1.37419 -0.89433 -0.89        1.37419 -0.89433 0.89   -1.12431 -0.89433 -0.89         1. 0. 0.
     511
     52  1.37419 -0.89433 0.89         -1.12431 -0.89433 -0.89         -1.12431 -0.89433 0.89  1. 0. 0.
     531
     54  1.37419 -0.89433 -0.89        1.37419 -0.89433 0.89   2.26414 0.364321 -4.44089e-16   1. 0. 0.
    55559
    5656#  terminating special property
     
    5959  25.0    0.6     -1.0 -1.0 -1.0     0.2        0 0 0 0
    60602
    61   -1.00456 0.23922 0.593333     5       1 0 0
     61  1.67084 -0.47478 -8.88178e-16 5       1 0 0
    62629
    6363  terminating special property
  • tests/regression/Tesselation/2/post/ConvexEnvelope.dat

    rebbd3d r1cf5df  
    11TITLE = "3D CONVEX SHELL"
    22VARIABLES = "X" "Y" "Z" "U"
    3 ZONE T="0- H08_ H09_ H11", N=8, E=12, DATAPACKING=POINT, ZONETYPE=FETRIANGLE
     3ZONE T="test", N=8, E=12, DATAPACKING=POINT, ZONETYPE=FETRIANGLE
    449.78209 2.64589 2.64589 0
    559.78209 2.64589 4.42589 0
     
    13131 3 4
    14141 4 7
     154 6 7
    15163 4 5
    16 1 7 8
    17 1 2 8
    18 4 6 7
     174 5 6
    19182 3 5
    20 4 5 6
    21 6 7 8
    22 1 2 3
    23192 5 8
    24205 6 8
     216 7 8
     221 2 7
     232 7 8
     241 2 3
  • tests/regression/Tesselation/2/post/ConvexEnvelope.r3d

    rebbd3d r1cf5df  
    3434  1.37419 -0.89433 -0.89        0.12489 1.24767 -0.89   -1.12431 -0.89433 -0.89         1. 0. 0.
    35351
    36   2.26414 0.364321 -4.44089e-16         0.12489 1.24767 -0.89   0.12489 1.24767 0.89    1. 0. 0.
    37 1
    38   1.37419 -0.89433 -0.89        -1.12431 -0.89433 -0.89         -1.12431 -0.89433 0.89  1. 0. 0.
    39 1
    40   1.37419 -0.89433 -0.89        1.37419 -0.89433 0.89   -1.12431 -0.89433 0.89  1. 0. 0.
    41 1
    4236  0.12489 1.24767 -0.89         -2.01426 0.364321 -4.44089e-16  -1.12431 -0.89433 -0.89         1. 0. 0.
    43371
    44   1.37419 -0.89433 0.89         2.26414 0.364321 -4.44089e-16   0.12489 1.24767 0.89    1. 0. 0.
     38  2.26414 0.364321 -4.44089e-16         0.12489 1.24767 -0.89   0.12489 1.24767 0.89    1. 0. 0.
    45391
    4640  0.12489 1.24767 -0.89         0.12489 1.24767 0.89    -2.01426 0.364321 -4.44089e-16  1. 0. 0.
    47411
    48   -2.01426 0.364321 -4.44089e-16        -1.12431 -0.89433 -0.89         -1.12431 -0.89433 0.89  1. 0. 0.
    49 1
    50   1.37419 -0.89433 -0.89        1.37419 -0.89433 0.89   2.26414 0.364321 -4.44089e-16   1. 0. 0.
     42  1.37419 -0.89433 0.89         2.26414 0.364321 -4.44089e-16   0.12489 1.24767 0.89    1. 0. 0.
    51431
    5244  1.37419 -0.89433 0.89         0.12489 1.24767 0.89    -1.12431 -0.89433 0.89  1. 0. 0.
    53451
    5446  0.12489 1.24767 0.89  -2.01426 0.364321 -4.44089e-16  -1.12431 -0.89433 0.89  1. 0. 0.
     471
     48  -2.01426 0.364321 -4.44089e-16        -1.12431 -0.89433 -0.89         -1.12431 -0.89433 0.89  1. 0. 0.
     491
     50  1.37419 -0.89433 -0.89        1.37419 -0.89433 0.89   -1.12431 -0.89433 -0.89         1. 0. 0.
     511
     52  1.37419 -0.89433 0.89         -1.12431 -0.89433 -0.89         -1.12431 -0.89433 0.89  1. 0. 0.
     531
     54  1.37419 -0.89433 -0.89        1.37419 -0.89433 0.89   2.26414 0.364321 -4.44089e-16   1. 0. 0.
    55559
    5656#  terminating special property
     
    5959  25.0    0.6     -1.0 -1.0 -1.0     0.2        0 0 0 0
    60602
    61   -1.00456 0.23922 0.593333     5       1 0 0
     61  1.67084 -0.47478 -8.88178e-16 5       1 0 0
    62629
    6363  terminating special property
  • tests/regression/Tesselation/2/post/NonConvexEnvelope.dat

    rebbd3d r1cf5df  
    11TITLE = "3D CONVEX SHELL"
    22VARIABLES = "X" "Y" "Z" "U"
    3 ZONE T="0- H08_ H09_ H11", N=8, E=12, DATAPACKING=POINT, ZONETYPE=FETRIANGLE
     3ZONE T="test", N=8, E=12, DATAPACKING=POINT, ZONETYPE=FETRIANGLE
    449.78209 2.64589 2.64589 0
    559.78209 2.64589 4.42589 0
     
    13131 3 4
    14141 4 7
     154 6 7
    15163 4 5
    16 1 7 8
    17 1 2 8
    18 4 6 7
     174 5 6
    19182 3 5
    20 4 5 6
    21 6 7 8
    22 1 2 3
    23192 5 8
    24205 6 8
     216 7 8
     221 2 7
     232 7 8
     241 2 3
  • tests/regression/Tesselation/2/post/NonConvexEnvelope.r3d

    rebbd3d r1cf5df  
    3434  1.37419 -0.89433 -0.89        0.12489 1.24767 -0.89   -1.12431 -0.89433 -0.89         1. 0. 0.
    35351
    36   2.26414 0.364321 -4.44089e-16         0.12489 1.24767 -0.89   0.12489 1.24767 0.89    1. 0. 0.
    37 1
    38   1.37419 -0.89433 -0.89        -1.12431 -0.89433 -0.89         -1.12431 -0.89433 0.89  1. 0. 0.
    39 1
    40   1.37419 -0.89433 -0.89        1.37419 -0.89433 0.89   -1.12431 -0.89433 0.89  1. 0. 0.
    41 1
    4236  0.12489 1.24767 -0.89         -2.01426 0.364321 -4.44089e-16  -1.12431 -0.89433 -0.89         1. 0. 0.
    43371
    44   1.37419 -0.89433 0.89         2.26414 0.364321 -4.44089e-16   0.12489 1.24767 0.89    1. 0. 0.
     38  2.26414 0.364321 -4.44089e-16         0.12489 1.24767 -0.89   0.12489 1.24767 0.89    1. 0. 0.
    45391
    4640  0.12489 1.24767 -0.89         0.12489 1.24767 0.89    -2.01426 0.364321 -4.44089e-16  1. 0. 0.
    47411
    48   -2.01426 0.364321 -4.44089e-16        -1.12431 -0.89433 -0.89         -1.12431 -0.89433 0.89  1. 0. 0.
    49 1
    50   1.37419 -0.89433 -0.89        1.37419 -0.89433 0.89   2.26414 0.364321 -4.44089e-16   1. 0. 0.
     42  1.37419 -0.89433 0.89         2.26414 0.364321 -4.44089e-16   0.12489 1.24767 0.89    1. 0. 0.
    51431
    5244  1.37419 -0.89433 0.89         0.12489 1.24767 0.89    -1.12431 -0.89433 0.89  1. 0. 0.
    53451
    5446  0.12489 1.24767 0.89  -2.01426 0.364321 -4.44089e-16  -1.12431 -0.89433 0.89  1. 0. 0.
     471
     48  -2.01426 0.364321 -4.44089e-16        -1.12431 -0.89433 -0.89         -1.12431 -0.89433 0.89  1. 0. 0.
     491
     50  1.37419 -0.89433 -0.89        1.37419 -0.89433 0.89   -1.12431 -0.89433 -0.89         1. 0. 0.
     511
     52  1.37419 -0.89433 0.89         -1.12431 -0.89433 -0.89         -1.12431 -0.89433 0.89  1. 0. 0.
     531
     54  1.37419 -0.89433 -0.89        1.37419 -0.89433 0.89   2.26414 0.364321 -4.44089e-16   1. 0. 0.
    55559
    5656#  terminating special property
     
    5959  25.0    0.6     -1.0 -1.0 -1.0     0.2        0 0 0 0
    60602
    61   -1.00456 0.23922 0.593333     5       1 0 0
     61  1.67084 -0.47478 -8.88178e-16 5       1 0 0
    62629
    6363  terminating special property
  • tests/regression/Tesselation/3/post/NonConvexEnvelope.dat

    rebbd3d r1cf5df  
    11TITLE = "3D CONVEX SHELL"
    22VARIABLES = "X" "Y" "Z" "U"
    3 ZONE T="0- H49_ H50_ H51", N=44, E=86, DATAPACKING=POINT, ZONETYPE=FETRIANGLE
     3ZONE T="test", N=44, E=86, DATAPACKING=POINT, ZONETYPE=FETRIANGLE
    446.9077 1.1106 0.1214 1
    550.3612 -3.628 1.323 1
     
    28282.8131 1.4776 2.5103 0
    29293.9137 2.2936 1.3739 0
    30 2.159 2.5738 1.2698 2
     302.159 2.5738 1.2698 5
    31313.6606 -0.4593 2.1396 2
    32323.2007 -1.4419 0.7311 4
    33 -3.3002 2.3589 0.0094 5
     33-3.3002 2.3589 0.0094 8
    3434-4.377 1.6962 -1.2433 3
    35355.2593 1.4547 -1.7445 0
     
    40405.2727 1.6068 1.2828 2
    4141-6.2394 4.6427 0.0632 0
    42 -4.4738 4.5591 -0.1458 1
     42-4.4738 4.5591 -0.1458 3
    4343-5.5506 3.8964 -1.3985 0
    4444-6.7081 0.9923 0.6224 2
     
    49491 32 44
    50501 32 35
    51 32 33 44
    52511 34 35
    535223 32 35
    54 23 32 33
     5317 23 35
     548 17 35
     558 10 17
     563 8 10
     573 8 35
     583 4 35
     594 29 35
     6029 34 35
     612 3 4
     622 4 29
     632 15 29
     6415 28 29
     6528 29 34
     662 7 15
     677 14 15
     6814 15 28
     6914 25 28
     7025 28 37
     7128 34 37
     721 34 37
     731 37 44
     7425 26 37
     7525 26 27
     7626 27 33
    557726 33 44
    56 1 34 37
    57 29 34 35
    58 17 23 35
    59 18 23 33
    60 26 27 33
    617826 37 44
    62 1 37 44
    63 28 34 37
    64 28 29 34
    65 4 29 35
    66 17 18 23
    67 8 17 35
    68 18 27 33
    69 25 26 27
    70 25 26 37
    71 25 28 37
    72 15 28 29
    73 2 4 29
    74 3 4 35
    75 9 17 18
    76 8 10 17
    77 3 8 35
    78 16 18 27
    797914 25 27
    80 14 25 28
    81 14 15 28
    82 2 15 29
    83 2 3 4
    84 9 10 17
    85 9 18 31
    86 3 8 10
    87 16 18 30
    88 16 27 30
    898014 27 30
    90 7 14 15
    91 2 7 15
    92 2 3 5
    93 9 10 12
    94 9 19 31
    95 18 30 31
    96 3 10 12
    97816 14 30
     826 24 30
     8324 30 36
     8430 36 39
     8527 30 39
     866 7 24
    98876 7 14
    99 2 5 7
    100 3 5 12
    101 9 12 13
    102 9 13 19
    103 13 19 31
    104 30 31 39
    105 6 24 30
    106 6 7 24
    107 5 7 11
    108 5 12 22
    109 12 13 21
    110 13 21 31
    111 27 30 39
    112 31 39 40
    113 24 30 36
    114887 11 24
    115 5 11 22
    116 12 21 22
    117 21 31 43
    118 31 40 43
    119 40 42 43
    120 41 42 43
    121 21 41 43
    122 20 21 41
     8911 20 24
    1239020 24 41
    1249124 36 41
    1259236 41 42
     9311 20 22
     945 11 22
     955 7 11
     962 5 7
     9727 30 39
     9816 27 30
     9916 18 30
     10016 18 27
     10118 27 33
     10218 23 33
     10336 38 39
    12610436 38 42
     10518 30 31
     10630 31 39
     10731 39 40
     1089 18 31
     1099 17 18
     11017 18 23
     1119 19 31
     1129 13 19
     11313 19 31
     11413 21 31
     11521 31 43
     11631 40 43
     1179 12 13
     1189 10 12
     1199 10 17
     12012 13 21
     12112 21 22
     1225 12 22
     1233 5 12
     1242 3 5
     1253 10 12
     12620 21 22
     12720 21 41
     12821 41 43
     12941 42 43
     13023 32 33
     13132 33 44
     13240 42 43
    12713338 40 42
    12813438 39 40
    129 36 38 39
    130 30 36 39
    131 27 30 39
    132 11 20 24
    133 11 20 22
    134 20 21 22
  • tests/regression/Tesselation/3/post/NonConvexEnvelope.r3d

    rebbd3d r1cf5df  
    160160  7.33693 1.04442 0.0886712     5.68853 1.38852 -1.77723        5.55043 -0.952879 -0.490929     1. 0. 0.
    1611611
     162  7.33693 1.04442 0.0886712     6.17523 -0.969279 1.17127       5.55043 -0.952879 -0.490929     1. 0. 0.
     1631
     164  3.62023 1.25552 -2.86813      5.68853 1.38852 -1.77723        5.55043 -0.952879 -0.490929     1. 0. 0.
     1651
     166  1.76663 -0.360379 -2.99373    3.62023 1.25552 -2.86813        5.55043 -0.952879 -0.490929     1. 0. 0.
     1671
     168  2.19193 -1.51408 -0.867629    1.76663 -0.360379 -2.99373      5.55043 -0.952879 -0.490929     1. 0. 0.
     1691
     170  2.19193 -1.51408 -0.867629    0.450934 -2.72908 -2.23353      1.76663 -0.360379 -2.99373      1. 0. 0.
     1711
     172  0.917634 -3.66448 -0.484829   2.19193 -1.51408 -0.867629      0.450934 -2.72908 -2.23353      1. 0. 0.
     1731
     174  0.917634 -3.66448 -0.484829   2.19193 -1.51408 -0.867629      5.55043 -0.952879 -0.490929     1. 0. 0.
     1751
     176  0.917634 -3.66448 -0.484829   1.92773 -2.57738 0.498071       5.55043 -0.952879 -0.490929     1. 0. 0.
     1771
     178  1.92773 -2.57738 0.498071     3.62993 -1.50808 0.698371       5.55043 -0.952879 -0.490929     1. 0. 0.
     1791
     180  3.62993 -1.50808 0.698371     6.17523 -0.969279 1.17127       5.55043 -0.952879 -0.490929     1. 0. 0.
     1811
     182  0.790434 -3.69418 1.29027     0.917634 -3.66448 -0.484829     1.92773 -2.57738 0.498071       1. 0. 0.
     1831
     184  0.790434 -3.69418 1.29027     1.92773 -2.57738 0.498071       3.62993 -1.50808 0.698371       1. 0. 0.
     1851
     186  0.790434 -3.69418 1.29027     2.06173 -1.39848 1.79787        3.62993 -1.50808 0.698371       1. 0. 0.
     1871
     188  2.06173 -1.39848 1.79787      4.08983 -0.525479 2.10687       3.62993 -1.50808 0.698371       1. 0. 0.
     1891
     190  4.08983 -0.525479 2.10687     3.62993 -1.50808 0.698371       6.17523 -0.969279 1.17127       1. 0. 0.
     1911
     192  0.790434 -3.69418 1.29027     -0.287266 -1.67078 2.48017      2.06173 -1.39848 1.79787        1. 0. 0.
     1931
     194  -0.287266 -1.67078 2.48017    1.46453 0.112321 2.50927        2.06173 -1.39848 1.79787        1. 0. 0.
     1951
     196  1.46453 0.112321 2.50927      2.06173 -1.39848 1.79787        4.08983 -0.525479 2.10687       1. 0. 0.
     1971
     198  1.46453 0.112321 2.50927      3.24233 1.41142 2.47757         4.08983 -0.525479 2.10687       1. 0. 0.
     1991
     200  3.24233 1.41142 2.47757       4.08983 -0.525479 2.10687       5.70193 1.54062 1.25007         1. 0. 0.
     2011
     202  4.08983 -0.525479 2.10687     6.17523 -0.969279 1.17127       5.70193 1.54062 1.25007         1. 0. 0.
     2031
     204  7.33693 1.04442 0.0886712     6.17523 -0.969279 1.17127       5.70193 1.54062 1.25007         1. 0. 0.
     2051
     206  7.33693 1.04442 0.0886712     5.70193 1.54062 1.25007         7.56833 1.97852 -0.00632877     1. 0. 0.
     2071
     208  3.24233 1.41142 2.47757       4.34293 2.22742 1.34117         5.70193 1.54062 1.25007         1. 0. 0.
     2091
     210  3.24233 1.41142 2.47757       4.34293 2.22742 1.34117         2.58823 2.50762 1.23707         1. 0. 0.
     2111
     212  4.34293 2.22742 1.34117       2.58823 2.50762 1.23707         5.11553 2.70122 -0.710229       1. 0. 0.
     2131
     214  4.34293 2.22742 1.34117       5.11553 2.70122 -0.710229       7.56833 1.97852 -0.00632877     1. 0. 0.
     2151
     216  4.34293 2.22742 1.34117       5.70193 1.54062 1.25007         7.56833 1.97852 -0.00632877     1. 0. 0.
     2171
     218  1.46453 0.112321 2.50927      3.24233 1.41142 2.47757         2.58823 2.50762 1.23707         1. 0. 0.
     2191
     220  1.46453 0.112321 2.50927      2.58823 2.50762 1.23707         -2.87097 2.29272 -0.0233288     1. 0. 0.
     2211
     222  -0.759066 -0.265179 1.48487   1.46453 0.112321 2.50927        -2.87097 2.29272 -0.0233288     1. 0. 0.
     2231
     224  -0.759066 -0.265179 1.48487   -3.66127 0.565021 1.57007       -2.87097 2.29272 -0.0233288     1. 0. 0.
     2251
     226  -3.66127 0.565021 1.57007     -2.87097 2.29272 -0.0233288     -4.83487 2.76522 1.41487        1. 0. 0.
     2271
     228  -2.87097 2.29272 -0.0233288   -4.83487 2.76522 1.41487        -4.04457 4.49292 -0.178529      1. 0. 0.
     2291
     230  2.58823 2.50762 1.23707       -2.87097 2.29272 -0.0233288     -4.04457 4.49292 -0.178529      1. 0. 0.
     2311
     232  -0.759066 -0.265179 1.48487   -0.287266 -1.67078 2.48017      -3.66127 0.565021 1.57007       1. 0. 0.
     2331
     234  -0.759066 -0.265179 1.48487   -0.287266 -1.67078 2.48017      1.46453 0.112321 2.50927        1. 0. 0.
     2351
     236  -0.287266 -1.67078 2.48017    -2.45927 -1.63678 1.72157       -3.66127 0.565021 1.57007       1. 0. 0.
     2371
     238  -2.45927 -1.63678 1.72157     -4.75167 -1.93408 0.935971      -3.66127 0.565021 1.57007       1. 0. 0.
     2391
     240  -4.75167 -1.93408 0.935971    -3.66127 0.565021 1.57007       -6.27887 0.926121 0.589671      1. 0. 0.
     2411
     242  -3.66127 0.565021 1.57007     -4.83487 2.76522 1.41487        -6.27887 0.926121 0.589671      1. 0. 0.
     2431
     244  -4.83487 2.76522 1.41487      -6.27887 0.926121 0.589671      -7.11497 2.49352 0.479071       1. 0. 0.
     2451
     246  -2.45927 -1.63678 1.72157     -4.75167 -1.93408 0.935971      -3.90927 -3.49908 0.839771      1. 0. 0.
     2471
     248  -1.52417 -3.64138 0.503471    -2.45927 -1.63678 1.72157       -3.90927 -3.49908 0.839771      1. 0. 0.
     2491
     250  -1.52417 -3.64138 0.503471    -0.287266 -1.67078 2.48017      -2.45927 -1.63678 1.72157       1. 0. 0.
     2511
     252  0.790434 -3.69418 1.29027     -1.52417 -3.64138 0.503471      -0.287266 -1.67078 2.48017      1. 0. 0.
     2531
     254  2.58823 2.50762 1.23707       -2.87097 2.29272 -0.0233288     -4.04457 4.49292 -0.178529      1. 0. 0.
     2551
     256  1.15633 1.11082 0.326671      2.58823 2.50762 1.23707         -2.87097 2.29272 -0.0233288     1. 0. 0.
     2571
     258  1.15633 1.11082 0.326671      1.03283 1.01972 -2.14533        -2.87097 2.29272 -0.0233288     1. 0. 0.
     2591
     260  1.15633 1.11082 0.326671      1.03283 1.01972 -2.14533        2.58823 2.50762 1.23707         1. 0. 0.
     2611
     262  1.03283 1.01972 -2.14533      2.58823 2.50762 1.23707         5.11553 2.70122 -0.710229       1. 0. 0.
     2631
     264  1.03283 1.01972 -2.14533      3.62023 1.25552 -2.86813        5.11553 2.70122 -0.710229       1. 0. 0.
     2651
     266  -4.83487 2.76522 1.41487      -5.81017 4.57652 0.0304712      -4.04457 4.49292 -0.178529      1. 0. 0.
     2671
     268  -4.83487 2.76522 1.41487      -5.81017 4.57652 0.0304712      -7.11497 2.49352 0.479071       1. 0. 0.
     2691
     270  1.03283 1.01972 -2.14533      -2.87097 2.29272 -0.0233288     -3.94777 1.63002 -1.27603       1. 0. 0.
     2711
     272  -2.87097 2.29272 -0.0233288   -3.94777 1.63002 -1.27603       -4.04457 4.49292 -0.178529      1. 0. 0.
     2731
     274  -3.94777 1.63002 -1.27603     -4.04457 4.49292 -0.178529      -5.12137 3.83022 -1.43123       1. 0. 0.
     2751
     276  -0.573766 -1.42458 -2.91753   1.03283 1.01972 -2.14533        -3.94777 1.63002 -1.27603       1. 0. 0.
     2771
     278  -0.573766 -1.42458 -2.91753   1.76663 -0.360379 -2.99373      1.03283 1.01972 -2.14533        1. 0. 0.
     2791
     280  1.76663 -0.360379 -2.99373    1.03283 1.01972 -2.14533        3.62023 1.25552 -2.86813        1. 0. 0.
     2811
     282  -0.573766 -1.42458 -2.91753   -2.77417 -0.570279 -1.12083     -3.94777 1.63002 -1.27603       1. 0. 0.
     2831
     284  -0.573766 -1.42458 -2.91753   -2.49667 -2.18078 -1.79993      -2.77417 -0.570279 -1.12083     1. 0. 0.
     2851
     286  -2.49667 -2.18078 -1.79993    -2.77417 -0.570279 -1.12083     -3.94777 1.63002 -1.27603       1. 0. 0.
     2871
     288  -2.49667 -2.18078 -1.79993    -4.17327 -2.53828 -0.635229     -3.94777 1.63002 -1.27603       1. 0. 0.
     2891
     290  -4.17327 -2.53828 -0.635229   -3.94777 1.63002 -1.27603       -6.42617 1.74722 -0.982629      1. 0. 0.
     2911
     292  -3.94777 1.63002 -1.27603     -5.12137 3.83022 -1.43123       -6.42617 1.74722 -0.982629      1. 0. 0.
     2931
     294  -0.573766 -1.42458 -2.91753   -1.62867 -3.74268 -1.79493      -2.49667 -2.18078 -1.79993      1. 0. 0.
     2951
     296  -0.573766 -1.42458 -2.91753   0.450934 -2.72908 -2.23353      -1.62867 -3.74268 -1.79493      1. 0. 0.
     2971
     298  -0.573766 -1.42458 -2.91753   0.450934 -2.72908 -2.23353      1.76663 -0.360379 -2.99373      1. 0. 0.
     2991
     300  -1.62867 -3.74268 -1.79493    -2.49667 -2.18078 -1.79993      -4.17327 -2.53828 -0.635229     1. 0. 0.
     3011
     302  -1.62867 -3.74268 -1.79493    -4.17327 -2.53828 -0.635229     -3.90927 -3.49908 0.839771      1. 0. 0.
     3031
     304  -1.52417 -3.64138 0.503471    -1.62867 -3.74268 -1.79493      -3.90927 -3.49908 0.839771      1. 0. 0.
     3051
     306  0.917634 -3.66448 -0.484829   -1.52417 -3.64138 0.503471      -1.62867 -3.74268 -1.79493      1. 0. 0.
     3071
     308  0.790434 -3.69418 1.29027     0.917634 -3.66448 -0.484829     -1.52417 -3.64138 0.503471      1. 0. 0.
     3091
     310  0.917634 -3.66448 -0.484829   0.450934 -2.72908 -2.23353      -1.62867 -3.74268 -1.79493      1. 0. 0.
     3111
     312  -4.75167 -1.93408 0.935971    -4.17327 -2.53828 -0.635229     -3.90927 -3.49908 0.839771      1. 0. 0.
     3131
     314  -4.75167 -1.93408 0.935971    -4.17327 -2.53828 -0.635229     -6.27887 0.926121 0.589671      1. 0. 0.
     3151
     316  -4.17327 -2.53828 -0.635229   -6.27887 0.926121 0.589671      -6.42617 1.74722 -0.982629      1. 0. 0.
     3171
     318  -6.27887 0.926121 0.589671    -7.11497 2.49352 0.479071       -6.42617 1.74722 -0.982629      1. 0. 0.
     3191
     320  3.62023 1.25552 -2.86813      5.68853 1.38852 -1.77723        5.11553 2.70122 -0.710229       1. 0. 0.
     3211
    162322  5.68853 1.38852 -1.77723      5.11553 2.70122 -0.710229       7.56833 1.97852 -0.00632877     1. 0. 0.
    1633231
    164   7.33693 1.04442 0.0886712     6.17523 -0.969279 1.17127       5.55043 -0.952879 -0.490929     1. 0. 0.
    165 1
    166   3.62023 1.25552 -2.86813      5.68853 1.38852 -1.77723        5.55043 -0.952879 -0.490929     1. 0. 0.
    167 1
    168   3.62023 1.25552 -2.86813      5.68853 1.38852 -1.77723        5.11553 2.70122 -0.710229       1. 0. 0.
    169 1
    170   4.34293 2.22742 1.34117       5.11553 2.70122 -0.710229       7.56833 1.97852 -0.00632877     1. 0. 0.
    171 1
    172   7.33693 1.04442 0.0886712     6.17523 -0.969279 1.17127       5.70193 1.54062 1.25007         1. 0. 0.
    173 1
    174   3.62993 -1.50808 0.698371     6.17523 -0.969279 1.17127       5.55043 -0.952879 -0.490929     1. 0. 0.
    175 1
    176   1.76663 -0.360379 -2.99373    3.62023 1.25552 -2.86813        5.55043 -0.952879 -0.490929     1. 0. 0.
    177 1
    178   1.03283 1.01972 -2.14533      3.62023 1.25552 -2.86813        5.11553 2.70122 -0.710229       1. 0. 0.
    179 1
    180   4.34293 2.22742 1.34117       2.58823 2.50762 1.23707         5.11553 2.70122 -0.710229       1. 0. 0.
    181 1
    182   4.34293 2.22742 1.34117       5.70193 1.54062 1.25007         7.56833 1.97852 -0.00632877     1. 0. 0.
    183 1
    184   7.33693 1.04442 0.0886712     5.70193 1.54062 1.25007         7.56833 1.97852 -0.00632877     1. 0. 0.
    185 1
    186   4.08983 -0.525479 2.10687     6.17523 -0.969279 1.17127       5.70193 1.54062 1.25007         1. 0. 0.
    187 1
    188   4.08983 -0.525479 2.10687     3.62993 -1.50808 0.698371       6.17523 -0.969279 1.17127       1. 0. 0.
    189 1
    190   1.92773 -2.57738 0.498071     3.62993 -1.50808 0.698371       5.55043 -0.952879 -0.490929     1. 0. 0.
    191 1
    192   1.76663 -0.360379 -2.99373    1.03283 1.01972 -2.14533        3.62023 1.25552 -2.86813        1. 0. 0.
    193 1
    194   2.19193 -1.51408 -0.867629    1.76663 -0.360379 -2.99373      5.55043 -0.952879 -0.490929     1. 0. 0.
    195 1
    196   1.03283 1.01972 -2.14533      2.58823 2.50762 1.23707         5.11553 2.70122 -0.710229       1. 0. 0.
    197 1
    198   3.24233 1.41142 2.47757       4.34293 2.22742 1.34117         2.58823 2.50762 1.23707         1. 0. 0.
    199 1
    200   3.24233 1.41142 2.47757       4.34293 2.22742 1.34117         5.70193 1.54062 1.25007         1. 0. 0.
    201 1
    202   3.24233 1.41142 2.47757       4.08983 -0.525479 2.10687       5.70193 1.54062 1.25007         1. 0. 0.
    203 1
    204   2.06173 -1.39848 1.79787      4.08983 -0.525479 2.10687       3.62993 -1.50808 0.698371       1. 0. 0.
    205 1
    206   0.790434 -3.69418 1.29027     1.92773 -2.57738 0.498071       3.62993 -1.50808 0.698371       1. 0. 0.
    207 1
    208   0.917634 -3.66448 -0.484829   1.92773 -2.57738 0.498071       5.55043 -0.952879 -0.490929     1. 0. 0.
    209 1
    210   -0.573766 -1.42458 -2.91753   1.76663 -0.360379 -2.99373      1.03283 1.01972 -2.14533        1. 0. 0.
    211 1
    212   2.19193 -1.51408 -0.867629    0.450934 -2.72908 -2.23353      1.76663 -0.360379 -2.99373      1. 0. 0.
    213 1
    214   0.917634 -3.66448 -0.484829   2.19193 -1.51408 -0.867629      5.55043 -0.952879 -0.490929     1. 0. 0.
    215 1
    216   1.15633 1.11082 0.326671      1.03283 1.01972 -2.14533        2.58823 2.50762 1.23707         1. 0. 0.
    217 1
    218   1.46453 0.112321 2.50927      3.24233 1.41142 2.47757         2.58823 2.50762 1.23707         1. 0. 0.
    219 1
    220   1.46453 0.112321 2.50927      3.24233 1.41142 2.47757         4.08983 -0.525479 2.10687       1. 0. 0.
    221 1
    222   1.46453 0.112321 2.50927      2.06173 -1.39848 1.79787        4.08983 -0.525479 2.10687       1. 0. 0.
    223 1
    224   0.790434 -3.69418 1.29027     2.06173 -1.39848 1.79787        3.62993 -1.50808 0.698371       1. 0. 0.
    225 1
    226   0.790434 -3.69418 1.29027     0.917634 -3.66448 -0.484829     1.92773 -2.57738 0.498071       1. 0. 0.
    227 1
    228   -0.573766 -1.42458 -2.91753   0.450934 -2.72908 -2.23353      1.76663 -0.360379 -2.99373      1. 0. 0.
    229 1
    230   -0.573766 -1.42458 -2.91753   1.03283 1.01972 -2.14533        -3.94777 1.63002 -1.27603       1. 0. 0.
    231 1
    232   0.917634 -3.66448 -0.484829   2.19193 -1.51408 -0.867629      0.450934 -2.72908 -2.23353      1. 0. 0.
    233 1
    234   1.15633 1.11082 0.326671      1.03283 1.01972 -2.14533        -2.87097 2.29272 -0.0233288     1. 0. 0.
    235 1
    236   1.15633 1.11082 0.326671      2.58823 2.50762 1.23707         -2.87097 2.29272 -0.0233288     1. 0. 0.
    237 1
    238   1.46453 0.112321 2.50927      2.58823 2.50762 1.23707         -2.87097 2.29272 -0.0233288     1. 0. 0.
    239 1
    240   -0.287266 -1.67078 2.48017    1.46453 0.112321 2.50927        2.06173 -1.39848 1.79787        1. 0. 0.
    241 1
    242   0.790434 -3.69418 1.29027     -0.287266 -1.67078 2.48017      2.06173 -1.39848 1.79787        1. 0. 0.
    243 1
    244   0.790434 -3.69418 1.29027     0.917634 -3.66448 -0.484829     -1.52417 -3.64138 0.503471      1. 0. 0.
    245 1
    246   -0.573766 -1.42458 -2.91753   0.450934 -2.72908 -2.23353      -1.62867 -3.74268 -1.79493      1. 0. 0.
    247 1
    248   -0.573766 -1.42458 -2.91753   -2.77417 -0.570279 -1.12083     -3.94777 1.63002 -1.27603       1. 0. 0.
    249 1
    250   1.03283 1.01972 -2.14533      -2.87097 2.29272 -0.0233288     -3.94777 1.63002 -1.27603       1. 0. 0.
    251 1
    252   0.917634 -3.66448 -0.484829   0.450934 -2.72908 -2.23353      -1.62867 -3.74268 -1.79493      1. 0. 0.
    253 1
    254   -0.759066 -0.265179 1.48487   1.46453 0.112321 2.50927        -2.87097 2.29272 -0.0233288     1. 0. 0.
    255 1
    256   -0.759066 -0.265179 1.48487   -0.287266 -1.67078 2.48017      1.46453 0.112321 2.50927        1. 0. 0.
    257 1
    258   0.790434 -3.69418 1.29027     -1.52417 -3.64138 0.503471      -0.287266 -1.67078 2.48017      1. 0. 0.
    259 1
    260   0.917634 -3.66448 -0.484829   -1.52417 -3.64138 0.503471      -1.62867 -3.74268 -1.79493      1. 0. 0.
    261 1
    262   -0.573766 -1.42458 -2.91753   -1.62867 -3.74268 -1.79493      -2.49667 -2.18078 -1.79993      1. 0. 0.
    263 1
    264   -0.573766 -1.42458 -2.91753   -2.49667 -2.18078 -1.79993      -2.77417 -0.570279 -1.12083     1. 0. 0.
    265 1
    266   -2.49667 -2.18078 -1.79993    -2.77417 -0.570279 -1.12083     -3.94777 1.63002 -1.27603       1. 0. 0.
    267 1
    268   -2.87097 2.29272 -0.0233288   -3.94777 1.63002 -1.27603       -4.04457 4.49292 -0.178529      1. 0. 0.
    269 1
    270   -0.759066 -0.265179 1.48487   -3.66127 0.565021 1.57007       -2.87097 2.29272 -0.0233288     1. 0. 0.
    271 1
    272   -0.759066 -0.265179 1.48487   -0.287266 -1.67078 2.48017      -3.66127 0.565021 1.57007       1. 0. 0.
    273 1
    274   -1.52417 -3.64138 0.503471    -0.287266 -1.67078 2.48017      -2.45927 -1.63678 1.72157       1. 0. 0.
    275 1
    276   -1.52417 -3.64138 0.503471    -1.62867 -3.74268 -1.79493      -3.90927 -3.49908 0.839771      1. 0. 0.
    277 1
    278   -1.62867 -3.74268 -1.79493    -2.49667 -2.18078 -1.79993      -4.17327 -2.53828 -0.635229     1. 0. 0.
    279 1
    280   -2.49667 -2.18078 -1.79993    -4.17327 -2.53828 -0.635229     -3.94777 1.63002 -1.27603       1. 0. 0.
    281 1
    282   2.58823 2.50762 1.23707       -2.87097 2.29272 -0.0233288     -4.04457 4.49292 -0.178529      1. 0. 0.
    283 1
    284   -3.94777 1.63002 -1.27603     -4.04457 4.49292 -0.178529      -5.12137 3.83022 -1.43123       1. 0. 0.
    285 1
    286   -3.66127 0.565021 1.57007     -2.87097 2.29272 -0.0233288     -4.83487 2.76522 1.41487        1. 0. 0.
    287 1
    288   -0.287266 -1.67078 2.48017    -2.45927 -1.63678 1.72157       -3.66127 0.565021 1.57007       1. 0. 0.
    289 1
    290   -1.52417 -3.64138 0.503471    -2.45927 -1.63678 1.72157       -3.90927 -3.49908 0.839771      1. 0. 0.
    291 1
    292   -1.62867 -3.74268 -1.79493    -4.17327 -2.53828 -0.635229     -3.90927 -3.49908 0.839771      1. 0. 0.
    293 1
    294   -4.17327 -2.53828 -0.635229   -3.94777 1.63002 -1.27603       -6.42617 1.74722 -0.982629      1. 0. 0.
    295 1
    296   -3.94777 1.63002 -1.27603     -5.12137 3.83022 -1.43123       -6.42617 1.74722 -0.982629      1. 0. 0.
    297 1
    298324  -5.12137 3.83022 -1.43123     -7.11497 2.49352 0.479071       -6.42617 1.74722 -0.982629      1. 0. 0.
    2993251
    300   -6.27887 0.926121 0.589671    -7.11497 2.49352 0.479071       -6.42617 1.74722 -0.982629      1. 0. 0.
    301 1
    302   -4.17327 -2.53828 -0.635229   -6.27887 0.926121 0.589671      -6.42617 1.74722 -0.982629      1. 0. 0.
    303 1
    304   -4.75167 -1.93408 0.935971    -4.17327 -2.53828 -0.635229     -6.27887 0.926121 0.589671      1. 0. 0.
    305 1
    306   -4.75167 -1.93408 0.935971    -3.66127 0.565021 1.57007       -6.27887 0.926121 0.589671      1. 0. 0.
    307 1
    308   -3.66127 0.565021 1.57007     -4.83487 2.76522 1.41487        -6.27887 0.926121 0.589671      1. 0. 0.
    309 1
    310   -4.83487 2.76522 1.41487      -6.27887 0.926121 0.589671      -7.11497 2.49352 0.479071       1. 0. 0.
    311 1
    312   -4.83487 2.76522 1.41487      -5.81017 4.57652 0.0304712      -7.11497 2.49352 0.479071       1. 0. 0.
    313 1
    314326  -5.81017 4.57652 0.0304712    -5.12137 3.83022 -1.43123       -7.11497 2.49352 0.479071       1. 0. 0.
    3153271
    316328  -5.81017 4.57652 0.0304712    -4.04457 4.49292 -0.178529      -5.12137 3.83022 -1.43123       1. 0. 0.
    317 1
    318   -4.83487 2.76522 1.41487      -5.81017 4.57652 0.0304712      -4.04457 4.49292 -0.178529      1. 0. 0.
    319 1
    320   -2.87097 2.29272 -0.0233288   -4.83487 2.76522 1.41487        -4.04457 4.49292 -0.178529      1. 0. 0.
    321 1
    322   2.58823 2.50762 1.23707       -2.87097 2.29272 -0.0233288     -4.04457 4.49292 -0.178529      1. 0. 0.
    323 1
    324   -2.45927 -1.63678 1.72157     -4.75167 -1.93408 0.935971      -3.66127 0.565021 1.57007       1. 0. 0.
    325 1
    326   -2.45927 -1.63678 1.72157     -4.75167 -1.93408 0.935971      -3.90927 -3.49908 0.839771      1. 0. 0.
    327 1
    328   -4.75167 -1.93408 0.935971    -4.17327 -2.53828 -0.635229     -3.90927 -3.49908 0.839771      1. 0. 0.
    3293299
    330330#  terminating special property
     
    333333  25.0    0.6     -1.0 -1.0 -1.0     0.2        0 0 0 0
    3343342
    335   -4.27807 -2.65715 0.380171    5       1 0 0
     335  -4.99203 4.29989 -0.526429    5       1 0 0
    3363369
    337337  terminating special property
  • tests/testsuite.at

    rebbd3d r1cf5df  
    1212AT_CHECK([pwd],[ignore],[ignore])
    1313AT_CHECK([../../molecuilder -v], 0, [stdout], [ignore])
    14 AT_CHECK([fgrep molecuilder stdout], 0, [ignore], [ignore])
     14AT_CHECK([fgrep olecuilder stdout], 0, [ignore], [ignore])
    1515AT_CHECK([../../molecuilder -h], 0, [stdout], [ignore])
    1616AT_CHECK([fgrep "Give this help screen" stdout], 0, [ignore], [ignore])
    17 AT_CHECK([../../molecuilder -e], 0, [ignore], [stderr])
     17AT_CHECK([../../molecuilder -e], 255, [ignore], [stderr])
    1818AT_CHECK([fgrep "Not enough or invalid arguments" stderr], 0, [ignore], [ignore])
    1919AT_CHECK([../../molecuilder test.conf], 0, [stdout], [stderr])
     
    7878AT_SETUP([Simple configuration - invalid commands on present configs])
    7979AT_CHECK([/bin/cp -f ${abs_top_srcdir}/${AUTOTEST_PATH}/regression/Simple_configuration/7/pre/test.conf .], 0)
    80 AT_CHECK([../../molecuilder test.conf -e ${abs_top_srcdir}/src/ -t -s -b -E -c -b -a -U -T -u], 255, [ignore], [stderr])
    81 AT_CHECK([fgrep -c "Not enough or invalid" stderr], 0, [9
    82 ], [ignore])
     80AT_CHECK([../../molecuilder test.conf -e ${abs_top_srcdir}/src/ -t], 255, [ignore], [stderr])
     81AT_CHECK([fgrep -c "CRITICAL: Not enough or invalid" stderr], 0, [ignore], [ignore])
     82AT_CHECK([../../molecuilder test.conf -e ${abs_top_srcdir}/src/ -s -b -E -c -b -a -U -T -u], 255, [ignore], [stderr])
     83AT_CHECK([fgrep -c "CRITICAL: Not enough or invalid" stderr], 0, [ignore], [ignore])
     84AT_CHECK([../../molecuilder test.conf -e ${abs_top_srcdir}/src/ -b -E -c -b -a -U -T -u], 255, [ignore], [stderr])
     85AT_CHECK([fgrep -c "CRITICAL: Not enough or invalid" stderr], 0, [ignore], [ignore])
     86AT_CHECK([../../molecuilder test.conf -e ${abs_top_srcdir}/src/ -E -c -b -a -U -T -u], 255, [ignore], [stderr])
     87AT_CHECK([fgrep -c "CRITICAL: Not enough or invalid" stderr], 0, [ignore], [ignore])
     88AT_CHECK([../../molecuilder test.conf -e ${abs_top_srcdir}/src/ -c -b -a -U -T -u], 255, [ignore], [stderr])
     89AT_CHECK([fgrep -c "CRITICAL: Not enough or invalid" stderr], 0, [ignore], [ignore])
     90AT_CHECK([../../molecuilder test.conf -e ${abs_top_srcdir}/src/ -b -a -U -T -u], 255, [ignore], [stderr])
     91AT_CHECK([fgrep -c "CRITICAL: Not enough or invalid" stderr], 0, [ignore], [ignore])
     92AT_CHECK([../../molecuilder test.conf -e ${abs_top_srcdir}/src/ -a -U -T -u], 255, [ignore], [stderr])
     93AT_CHECK([fgrep -c "CRITICAL: Not enough or invalid" stderr], 0, [ignore], [ignore])
     94AT_CHECK([../../molecuilder test.conf -e ${abs_top_srcdir}/src/ -U -T -u], 255, [ignore], [stderr])
     95AT_CHECK([fgrep -c "CRITICAL: Not enough or invalid" stderr], 0, [ignore], [ignore])
     96AT_CHECK([../../molecuilder test.conf -e ${abs_top_srcdir}/src/ -T -u], 255, [ignore], [stderr])
     97AT_CHECK([fgrep -c "CRITICAL: Not enough or invalid" stderr], 0, [ignore], [ignore])
     98AT_CHECK([../../molecuilder test.conf -e ${abs_top_srcdir}/src/ -u], 255, [ignore], [stderr])
     99AT_CHECK([fgrep -c "CRITICAL: Not enough or invalid" stderr], 0, [ignore], [ignore])
    83100AT_CLEANUP
    84101
     
    88105AT_SETUP([Graph - DFS analysis])
    89106AT_CHECK([/bin/cp -f ${abs_top_srcdir}/${AUTOTEST_PATH}/regression/Graph/1/pre/test.conf .], 0)
    90 AT_CHECK([../../molecuilder test.conf -e ${abs_top_srcdir}/src/ -D 2.], 0, [stdout], [stderr])
     107AT_CHECK([../../molecuilder test.conf -e ${abs_top_srcdir}/src/ -vvv -D 2.], 0, [stdout], [stderr])
    91108AT_CHECK([fgrep -c "No rings were detected in the molecular structure." stdout], 0, [1
    92109], [ignore])
     
    134151AT_CHECK([file=ConvexEnvelope.dat; diff $file ${abs_top_srcdir}/${AUTOTEST_PATH}/regression/Tesselation/2/post/$file], 0, [ignore], [ignore])
    135152AT_CHECK([file=ConvexEnvelope.r3d; diff $file ${abs_top_srcdir}/${AUTOTEST_PATH}/regression/Tesselation/2/post/$file], 0, [ignore], [ignore])
    136 AT_CHECK([fgrep "RESULT: The summed volume is 16.401577 angstrom^3" stdout], 0, [ignore], [ignore])
     153AT_CHECK([fgrep "tesselated volume area is 16.4016 angstrom^3" stdout], 0, [ignore], [ignore])
    137154AT_CHECK([diff ConvexEnvelope.dat NonConvexEnvelope.dat], 0, [ignore], [ignore])
    138155AT_CLEANUP
     
    152169#AT_CHECK([file=ConvexEnvelope.dat; diff $file ${abs_top_srcdir}/${AUTOTEST_PATH}/regression/Tesselation/4/post/$file], 0, [ignore], [ignore])
    153170#AT_CHECK([file=ConvexEnvelope.r3d; diff $file ${abs_top_srcdir}/${AUTOTEST_PATH}/regression/Tesselation/4/post/$file], 0, [ignore], [ignore])
    154 #AT_CHECK([fgrep "RESULT: The summed volume is 16.401577 angstrom^3" stdout], 0, [ignore], [ignore])
     171#AT_CHECK([fgrep "tesselated volume area is 16.4016 angstrom^3" stdout], 0, [ignore], [ignore])
    155172#AT_CLEANUP
    156173
Note: See TracChangeset for help on using the changeset viewer.