Changeset e138de for src/vector.cpp


Ignore:
Timestamp:
Nov 4, 2009, 7:56:04 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:
1614174, e5ad5c
Parents:
7326b2
Message:

Huge change from ofstream * (const) out --> Log().

  • first shift was done via regular expressions
  • then via error messages from the code
  • note that class atom, class element and class molecule kept in parts their output stream, was they print to file.
  • make check runs fine
  • MISSING: Verbosity is not fixed for everything (i.e. if no endl; is present and next has Verbose(0) ...)

Signed-off-by: Frederik Heber <heber@…>

File:
1 edited

Legend:

Unmodified
Added
Removed
  • src/vector.cpp

    r7326b2 re138de  
    1010#include "memoryallocator.hpp"
    1111#include "leastsquaremin.hpp"
     12#include "log.hpp"
    1213#include "vector.hpp"
    1314#include "verbose.hpp"
     
    131132 * Tries to translate a vector into each adjacent neighbouring cell.
    132133 */
    133 void Vector::KeepPeriodic(ofstream *out, const double * const matrix)
     134void Vector::KeepPeriodic(const double * const matrix)
    134135{
    135136//  int N[NDIM];
     
    137138  //vector Shifted, TranslationVector;
    138139  Vector TestVector;
    139 //  *out << Verbose(1) << "Begin of KeepPeriodic." << endl;
    140 //  *out << Verbose(2) << "Vector is: ";
     140//  Log() << Verbose(1) << "Begin of KeepPeriodic." << endl;
     141//  Log() << Verbose(2) << "Vector is: ";
    141142//  Output(out);
    142 //  *out << endl;
     143//  Log() << Verbose(0) << endl;
    143144  TestVector.CopyVector(this);
    144145  TestVector.InverseMatrixMultiplication(matrix);
     
    152153  TestVector.MatrixMultiplication(matrix);
    153154  CopyVector(&TestVector);
    154 //  *out << Verbose(2) << "New corrected vector is: ";
     155//  Log() << Verbose(2) << "New corrected vector is: ";
    155156//  Output(out);
    156 //  *out << endl;
    157 //  *out << Verbose(1) << "End of KeepPeriodic." << endl;
     157//  Log() << Verbose(0) << endl;
     158//  Log() << Verbose(1) << "End of KeepPeriodic." << endl;
    158159};
    159160
     
    216217 * \return true -  \a this contains intersection point on return, false - line is parallel to plane
    217218 */
    218 bool Vector::GetIntersectionWithPlane(ofstream *out, const Vector * const PlaneNormal, const Vector * const PlaneOffset, const Vector * const Origin, const Vector * const LineVector)
     219bool Vector::GetIntersectionWithPlane(const Vector * const PlaneNormal, const Vector * const PlaneOffset, const Vector * const Origin, const Vector * const LineVector)
    219220{
    220221  double factor;
     
    225226  Direction.SubtractVector(Origin);
    226227  Direction.Normalize();
    227   //*out << Verbose(4) << "INFO: Direction is " << Direction << "." << endl;
     228  //Log() << Verbose(4) << "INFO: Direction is " << Direction << "." << endl;
    228229  factor = Direction.ScalarProduct(PlaneNormal);
    229230  if (factor < MYEPSILON) { // Uniqueness: line parallel to plane?
    230     *out << Verbose(2) << "WARNING: Line is parallel to plane, no intersection." << endl;
     231    Log() << Verbose(2) << "WARNING: Line is parallel to plane, no intersection." << endl;
    231232    return false;
    232233  }
     
    235236  factor = helper.ScalarProduct(PlaneNormal)/factor;
    236237  if (factor < MYEPSILON) { // Origin is in-plane
    237     //*out << Verbose(2) << "Origin of line is in-plane, simple." << endl;
     238    //Log() << Verbose(2) << "Origin of line is in-plane, simple." << endl;
    238239    CopyVector(Origin);
    239240    return true;
     
    242243  Direction.Scale(factor);
    243244  CopyVector(Origin);
    244   //*out << Verbose(4) << "INFO: Scaled direction is " << Direction << "." << endl;
     245  //Log() << Verbose(4) << "INFO: Scaled direction is " << Direction << "." << endl;
    245246  AddVector(&Direction);
    246247
     
    249250  helper.SubtractVector(PlaneOffset);
    250251  if (helper.ScalarProduct(PlaneNormal) < MYEPSILON) {
    251     //*out << Verbose(2) << "INFO: Intersection at " << *this << " is good." << endl;
     252    //Log() << Verbose(2) << "INFO: Intersection at " << *this << " is good." << endl;
    252253    return true;
    253254  } else {
    254     *out << Verbose(2) << "WARNING: Intersection point " << *this << " is not on plane." << endl;
     255    Log() << Verbose(2) << "WARNING: Intersection point " << *this << " is not on plane." << endl;
    255256    return false;
    256257  }
     
    263264 * \return distance to plane
    264265 */
    265 double Vector::DistanceToPlane(ofstream *out, const Vector * const PlaneNormal, const Vector * const PlaneOffset) const
     266double Vector::DistanceToPlane(const Vector * const PlaneNormal, const Vector * const PlaneOffset) const
    266267{
    267268  Vector temp;
     
    296297 * \return true - \a this will contain the intersection on return, false - lines are parallel
    297298 */
    298 bool Vector::GetIntersectionOfTwoLinesOnPlane(ofstream *out, const Vector * const Line1a, const Vector * const Line1b, const Vector * const Line2a, const Vector * const Line2b, const Vector *PlaneNormal)
     299bool Vector::GetIntersectionOfTwoLinesOnPlane(const Vector * const Line1a, const Vector * const Line1b, const Vector * const Line2a, const Vector * const Line2b, const Vector *PlaneNormal)
    299300{
    300301  bool result = true;
     
    320321  OtherDirection.Normalize();
    321322
    322   //*out << Verbose(4) << "INFO: Normalized Direction " << Direction << " and OtherDirection " << OtherDirection << "." << endl;
     323  //Log() << Verbose(4) << "INFO: Normalized Direction " << Direction << " and OtherDirection " << OtherDirection << "." << endl;
    323324
    324325  if (fabs(OtherDirection.ScalarProduct(&Direction) - 1.) < MYEPSILON) { // lines are parallel
     
    329330    else
    330331      return false;
    331     *out << Verbose(4) << "INFO: Intersection is " << *this << "." << endl;
     332    Log() << Verbose(4) << "INFO: Intersection is " << *this << "." << endl;
    332333    return true;
    333334  } else {
     
    342343
    343344    AuxiliaryNormal.MakeNormalVector(&OtherDirection, Normal);
    344     //*out << Verbose(4) << "INFO: PlaneNormal is " << *Normal << " and AuxiliaryNormal " << AuxiliaryNormal << "." << endl;
     345    //Log() << Verbose(4) << "INFO: PlaneNormal is " << *Normal << " and AuxiliaryNormal " << AuxiliaryNormal << "." << endl;
    345346
    346347    Distance.CopyVector(Line2a);
    347348    Distance.SubtractVector(Line1a);
    348     //*out << Verbose(4) << "INFO: Distance is " << Distance << "." << endl;
     349    //Log() << Verbose(4) << "INFO: Distance is " << Distance << "." << endl;
    349350    if (Distance.IsZero()) {
    350351      // offsets are equal, match found
     
    353354    } else {
    354355      CopyVector(Distance.Projection(&AuxiliaryNormal));
    355       //*out << Verbose(4) << "INFO: Projected Distance is " << *this << "." << endl;
     356      //Log() << Verbose(4) << "INFO: Projected Distance is " << *this << "." << endl;
    356357      double factor = Direction.ScalarProduct(&AuxiliaryNormal);
    357       //*out << Verbose(4) << "INFO: Scaling factor is " << factor << "." << endl;
     358      //Log() << Verbose(4) << "INFO: Scaling factor is " << factor << "." << endl;
    358359      Scale(1./(factor*factor));
    359       //*out << Verbose(4) << "INFO: Scaled Distance is " << *this << "." << endl;
     360      //Log() << Verbose(4) << "INFO: Scaled Distance is " << *this << "." << endl;
    360361      CopyVector(Projection(&Direction));
    361       //*out << Verbose(4) << "INFO: Distance, projected into Direction, is " << *this << "." << endl;
     362      //Log() << Verbose(4) << "INFO: Distance, projected into Direction, is " << *this << "." << endl;
    362363      if (this->IsZero())
    363364        result = false;
     
    371372  }
    372373  if (result)
    373     *out << Verbose(4) << "INFO: Intersection is " << *this << "." << endl;
     374    Log() << Verbose(4) << "INFO: Intersection is " << *this << "." << endl;
    374375
    375376  return result;
     
    492493    angle = this->ScalarProduct(y)/norm1/norm2;
    493494  // -1-MYEPSILON occured due to numerical imprecision, catch ...
    494   //cout << Verbose(2) << "INFO: acos(-1) = " << acos(-1) << ", acos(-1+MYEPSILON) = " << acos(-1+MYEPSILON) << ", acos(-1-MYEPSILON) = " << acos(-1-MYEPSILON) << "." << endl;
     495  //Log() << Verbose(2) << "INFO: acos(-1) = " << acos(-1) << ", acos(-1+MYEPSILON) = " << acos(-1+MYEPSILON) << ", acos(-1-MYEPSILON) = " << acos(-1-MYEPSILON) << "." << endl;
    495496  if (angle < -1)
    496497    angle = -1;
     
    628629/** Prints a 3dim vector.
    629630 * prints no end of line.
    630  * \param *out output stream
    631  */
    632 bool Vector::Output(ofstream *out) const
    633 {
    634   if (out != NULL) {
    635     *out << "(";
    636     for (int i=0;i<NDIM;i++) {
    637       *out << x[i];
    638       if (i != 2)
    639         *out << ",";
    640     }
    641     *out << ")";
    642     return true;
    643   } else
    644     return false;
     631 */
     632void Vector::Output() const
     633{
     634  Log() << Verbose(0) << "(";
     635  for (int i=0;i<NDIM;i++) {
     636    Log() << Verbose(0) << x[i];
     637    if (i != 2)
     638      Log() << Verbose(0) << ",";
     639  }
     640  Log() << Verbose(0) << ")";
    645641};
    646642
     
    751747      x[i] = C.x[i];
    752748  } else {
    753     cerr << "ERROR: inverse of matrix does not exists: det A = " << detA << "." << endl;
     749    eLog() << Verbose(0) << "ERROR: inverse of matrix does not exists: det A = " << detA << "." << endl;
    754750  }
    755751};
     
    777773  projection = ScalarProduct(n)/n->ScalarProduct(n);    // remove constancy from n (keep as logical one)
    778774  // withdraw projected vector twice from original one
    779   cout << Verbose(1) << "Vector: ";
    780   Output((ofstream *)&cout);
    781   cout << "\t";
     775  Log() << Verbose(1) << "Vector: ";
     776  Output();
     777  Log() << Verbose(0) << "\t";
    782778  for (int i=NDIM;i--;)
    783779    x[i] -= 2.*projection*n->x[i];
    784   cout << "Projected vector: ";
    785   Output((ofstream *)&cout);
    786   cout << endl;
     780  Log() << Verbose(0) << "Projected vector: ";
     781  Output();
     782  Log() << Verbose(0) << endl;
    787783};
    788784
     
    803799  x2.SubtractVector(y2);
    804800  if ((fabs(x1.Norm()) < MYEPSILON) || (fabs(x2.Norm()) < MYEPSILON) || (fabs(x1.Angle(&x2)) < MYEPSILON)) {
    805     cout << Verbose(4) << "WARNING: Given vectors are linear dependent." << endl;
     801    Log() << Verbose(4) << "WARNING: Given vectors are linear dependent." << endl;
    806802    return false;
    807803  }
    808 //  cout << Verbose(4) << "relative, first plane coordinates:";
     804//  Log() << Verbose(4) << "relative, first plane coordinates:";
    809805//  x1.Output((ofstream *)&cout);
    810 //  cout << endl;
    811 //  cout << Verbose(4) << "second plane coordinates:";
     806//  Log() << Verbose(0) << endl;
     807//  Log() << Verbose(4) << "second plane coordinates:";
    812808//  x2.Output((ofstream *)&cout);
    813 //  cout << endl;
     809//  Log() << Verbose(0) << endl;
    814810
    815811  this->x[0] = (x1.x[1]*x2.x[2] - x1.x[2]*x2.x[1]);
     
    837833  Zero();
    838834  if ((fabs(x1.Norm()) < MYEPSILON) || (fabs(x2.Norm()) < MYEPSILON) || (fabs(x1.Angle(&x2)) < MYEPSILON)) {
    839     cout << Verbose(4) << "WARNING: Given vectors are linear dependent." << endl;
     835    Log() << Verbose(4) << "WARNING: Given vectors are linear dependent." << endl;
    840836    return false;
    841837  }
    842 //  cout << Verbose(4) << "relative, first plane coordinates:";
     838//  Log() << Verbose(4) << "relative, first plane coordinates:";
    843839//  x1.Output((ofstream *)&cout);
    844 //  cout << endl;
    845 //  cout << Verbose(4) << "second plane coordinates:";
     840//  Log() << Verbose(0) << endl;
     841//  Log() << Verbose(4) << "second plane coordinates:";
    846842//  x2.Output((ofstream *)&cout);
    847 //  cout << endl;
     843//  Log() << Verbose(0) << endl;
    848844
    849845  this->x[0] = (x1.x[1]*x2.x[2] - x1.x[2]*x2.x[1]);
     
    888884  double norm;
    889885
    890   cout << Verbose(4);
    891   GivenVector->Output((ofstream *)&cout);
    892   cout << endl;
     886  Log() << Verbose(4);
     887  GivenVector->Output();
     888  Log() << Verbose(0) << endl;
    893889  for (j=NDIM;j--;)
    894890    Components[j] = -1;
     
    897893    if (fabs(GivenVector->x[j]) > MYEPSILON)
    898894      Components[Last++] = j;
    899   cout << Verbose(4) << Last << " Components != 0: (" << Components[0] << "," << Components[1] << "," << Components[2] << ")" << endl;
     895  Log() << Verbose(4) << Last << " Components != 0: (" << Components[0] << "," << Components[1] << "," << Components[2] << ")" << endl;
    900896
    901897  switch(Last) {
     
    929925double Vector::CutsPlaneAt(const Vector * const A, const Vector * const B, const Vector * const C) const
    930926{
    931 //  cout << Verbose(3) << "For comparison: ";
    932 //  cout << "A " << A->Projection(this) << "\t";
    933 //  cout << "B " << B->Projection(this) << "\t";
    934 //  cout << "C " << C->Projection(this) << "\t";
    935 //  cout << endl;
     927//  Log() << Verbose(3) << "For comparison: ";
     928//  Log() << Verbose(0) << "A " << A->Projection(this) << "\t";
     929//  Log() << Verbose(0) << "B " << B->Projection(this) << "\t";
     930//  Log() << Verbose(0) << "C " << C->Projection(this) << "\t";
     931//  Log() << Verbose(0) << endl;
    936932  return A->ScalarProduct(this);
    937933};
     
    947943
    948944  for (j=0;j<num;j++) {
    949     cout << Verbose(1) << j << "th atom's vector: ";
    950     (vectors[j])->Output((ofstream *)&cout);
    951     cout << endl;
     945    Log() << Verbose(1) << j << "th atom's vector: ";
     946    (vectors[j])->Output();
     947    Log() << Verbose(0) << endl;
    952948  }
    953949
     
    10691065    j += i+1;
    10701066    do {
    1071       cout << Verbose(0) << coords[i] << "[0.." << cell_size[j] << "]: ";
     1067      Log() << Verbose(0) << coords[i] << "[0.." << cell_size[j] << "]: ";
    10721068      cin >> x[i];
    10731069    } while (((x[i] < 0) || (x[i] >= cell_size[j])) && (check));
     
    11001096  B2 = cos(beta) * x2->Norm() * c;
    11011097  C = c * c;
    1102   cout << Verbose(2) << "A " << A << "\tB " << B1 << "\tC " << C << endl;
     1098  Log() << Verbose(2) << "A " << A << "\tB " << B1 << "\tC " << C << endl;
    11031099  int flag = 0;
    11041100  if (fabs(x1->x[0]) < MYEPSILON) { // check for zero components for the later flipping and back-flipping
     
    11391135  D2 = -y->x[0]/x1->x[0]*x1->x[2]+y->x[2];
    11401136  D3 = y->x[0]/x1->x[0]*A-B1;
    1141   cout << Verbose(2) << "D1 " << D1 << "\tD2 " << D2 << "\tD3 " << D3 << "\n";
     1137  Log() << Verbose(2) << "D1 " << D1 << "\tD2 " << D2 << "\tD3 " << D3 << "\n";
    11421138  if (fabs(D1) < MYEPSILON) {
    1143     cout << Verbose(2) << "D1 == 0!\n";
     1139    Log() << Verbose(2) << "D1 == 0!\n";
    11441140    if (fabs(D2) > MYEPSILON) {
    1145       cout << Verbose(3) << "D2 != 0!\n";
     1141      Log() << Verbose(3) << "D2 != 0!\n";
    11461142      x[2] = -D3/D2;
    11471143      E1 = A/x1->x[0] + x1->x[2]/x1->x[0]*D3/D2;
    11481144      E2 = -x1->x[1]/x1->x[0];
    1149       cout << Verbose(3) << "E1 " << E1 << "\tE2 " << E2 << "\n";
     1145      Log() << Verbose(3) << "E1 " << E1 << "\tE2 " << E2 << "\n";
    11501146      F1 = E1*E1 + 1.;
    11511147      F2 = -E1*E2;
    11521148      F3 = E1*E1 + D3*D3/(D2*D2) - C;
    1153       cout << Verbose(3) << "F1 " << F1 << "\tF2 " << F2 << "\tF3 " << F3 << "\n";
     1149      Log() << Verbose(3) << "F1 " << F1 << "\tF2 " << F2 << "\tF3 " << F3 << "\n";
    11541150      if (fabs(F1) < MYEPSILON) {
    1155         cout << Verbose(4) << "F1 == 0!\n";
    1156         cout << Verbose(4) << "Gleichungssystem linear\n";
     1151        Log() << Verbose(4) << "F1 == 0!\n";
     1152        Log() << Verbose(4) << "Gleichungssystem linear\n";
    11571153        x[1] = F3/(2.*F2);
    11581154      } else {
    11591155        p = F2/F1;
    11601156        q = p*p - F3/F1;
    1161         cout << Verbose(4) << "p " << p << "\tq " << q << endl;
     1157        Log() << Verbose(4) << "p " << p << "\tq " << q << endl;
    11621158        if (q < 0) {
    1163           cout << Verbose(4) << "q < 0" << endl;
     1159          Log() << Verbose(4) << "q < 0" << endl;
    11641160          return false;
    11651161        }
     
    11681164      x[0] =  A/x1->x[0] - x1->x[1]/x1->x[0]*x[1] + x1->x[2]/x1->x[0]*x[2];
    11691165    } else {
    1170       cout << Verbose(2) << "Gleichungssystem unterbestimmt\n";
     1166      Log() << Verbose(2) << "Gleichungssystem unterbestimmt\n";
    11711167      return false;
    11721168    }
     
    11741170    E1 = A/x1->x[0]+x1->x[1]/x1->x[0]*D3/D1;
    11751171    E2 = x1->x[1]/x1->x[0]*D2/D1 - x1->x[2];
    1176     cout << Verbose(2) << "E1 " << E1 << "\tE2 " << E2 << "\n";
     1172    Log() << Verbose(2) << "E1 " << E1 << "\tE2 " << E2 << "\n";
    11771173    F1 = E2*E2 + D2*D2/(D1*D1) + 1.;
    11781174    F2 = -(E1*E2 + D2*D3/(D1*D1));
    11791175    F3 = E1*E1 + D3*D3/(D1*D1) - C;
    1180     cout << Verbose(2) << "F1 " << F1 << "\tF2 " << F2 << "\tF3 " << F3 << "\n";
     1176    Log() << Verbose(2) << "F1 " << F1 << "\tF2 " << F2 << "\tF3 " << F3 << "\n";
    11811177    if (fabs(F1) < MYEPSILON) {
    1182       cout << Verbose(3) << "F1 == 0!\n";
    1183       cout << Verbose(3) << "Gleichungssystem linear\n";
     1178      Log() << Verbose(3) << "F1 == 0!\n";
     1179      Log() << Verbose(3) << "Gleichungssystem linear\n";
    11841180      x[2] = F3/(2.*F2);
    11851181    } else {
    11861182      p = F2/F1;
    11871183      q = p*p - F3/F1;
    1188       cout << Verbose(3) << "p " << p << "\tq " << q << endl;
     1184      Log() << Verbose(3) << "p " << p << "\tq " << q << endl;
    11891185      if (q < 0) {
    1190         cout << Verbose(3) << "q < 0" << endl;
     1186        Log() << Verbose(3) << "q < 0" << endl;
    11911187        return false;
    11921188      }
     
    12261222    for (j=2;j>=0;j--) {
    12271223      k = (i & pot(2,j)) << j;
    1228       cout << Verbose(2) << "k " << k << "\tpot(2,j) " << pot(2,j) << endl;
     1224      Log() << Verbose(2) << "k " << k << "\tpot(2,j) " << pot(2,j) << endl;
    12291225      sign[j] = (k == 0) ? 1. : -1.;
    12301226    }
    1231     cout << Verbose(2) << i << ": sign matrix is " << sign[0] << "\t" << sign[1] << "\t" << sign[2] << "\n";
     1227    Log() << Verbose(2) << i << ": sign matrix is " << sign[0] << "\t" << sign[1] << "\t" << sign[2] << "\n";
    12321228    // apply sign matrix
    12331229    for (j=NDIM;j--;)
     
    12351231    // calculate angle and check
    12361232    ang = x2->Angle (this);
    1237     cout << Verbose(1) << i << "th angle " << ang << "\tbeta " << cos(beta) << " :\t";
     1233    Log() << Verbose(1) << i << "th angle " << ang << "\tbeta " << cos(beta) << " :\t";
    12381234    if (fabs(ang - cos(beta)) < MYEPSILON) {
    12391235      break;
Note: See TracChangeset for help on using the changeset viewer.