Changeset c5038e


Ignore:
Timestamp:
Oct 12, 2011, 2:10:56 PM (14 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:
29cbe9
Parents:
c8b17b
git-author:
Frederik Heber <heber@…> (09/09/11 21:24:02)
git-committer:
Frederik Heber <heber@…> (10/12/11 14:10:56)
Message:

Made MatrixContent and VectorContent dimensions const by placing into extra class.

  • new classes MatrixDimension and VectorDimension.
  • they only displays getters to the outside. Thus, we may savely serialize them without having to disable the constness.
Location:
LinearAlgebra/src/LinearAlgebra
Files:
6 edited

Legend:

Unmodified
Added
Removed
  • LinearAlgebra/src/LinearAlgebra/LinearSystemOfEquations.cpp

    rc8b17b rc5038e  
    9797
    9898  // copy solution
    99   for (size_t i=0;i<x->dimension;i++) {
     99  for (size_t i=0;i<x->getDimension();i++) {
    100100    array[i] = x->at(i);
    101101  }
     
    113113
    114114  // copy solution
    115   for (size_t i=0;i<x->dimension;i++)
     115  for (size_t i=0;i<x->getDimension();i++)
    116116    v[i] = x->at(i);
    117117  return status;
     
    128128  int s;
    129129  if (IsSymmetric) { // use LU
    130     gsl_permutation * p = gsl_permutation_alloc (x->dimension);
     130    gsl_permutation * p = gsl_permutation_alloc (x->getDimension());
    131131    gsl_linalg_LU_decomp (A->content, p, &s);
    132132    gsl_linalg_LU_solve (A->content, p, b->content, x->content);
  • LinearAlgebra/src/LinearAlgebra/MatrixContent.cpp

    rc8b17b rc5038e  
    3333#include <set>
    3434
    35 using namespace std;
    36 
    3735
    3836/** Constructor for class MatrixContent.
     
    4139 */
    4240MatrixContent::MatrixContent(size_t _rows, size_t _columns) :
    43     rows(_rows),
    44     columns(_columns),
     41    MatrixDimension(_rows,_columns),
    4542    free_content_on_exit(true)
    4643{
    47   content = gsl_matrix_calloc(rows, columns);
     44  content = gsl_matrix_calloc(getRows(), getColumns());
    4845}
    4946
     
    5653 */
    5754MatrixContent::MatrixContent(size_t _rows, size_t _columns, MatrixBaseCase) :
    58     rows(_rows),
    59     columns(_columns),
     55    MatrixDimension(_rows,_columns),
    6056    free_content_on_exit(true)
    6157{}
     
    6763 */
    6864MatrixContent::MatrixContent(size_t _rows, size_t _columns, const double *src) :
    69     rows(_rows),
    70     columns(_columns),
     65    MatrixDimension(_rows,_columns),
    7166    free_content_on_exit(true)
    7267{
    73   content = gsl_matrix_calloc(rows, columns);
     68  content = gsl_matrix_calloc(getRows(), getColumns());
    7469  set(0,0, src[0]);
    7570  set(1,0, src[1]);
     
    9590 */
    9691MatrixContent::MatrixContent(size_t _row, size_t _column, std::istream &inputstream) :
     92  MatrixDimension(_row,_column),
    9793  content(NULL),
    98   rows(_row),
    99   columns(_column),
    10094  free_content_on_exit(true)
    10195{
    10296   // allocate matrix and set contents
    103   content = gsl_matrix_alloc(rows, columns);
     97  content = gsl_matrix_alloc(getRows(), getColumns());
    10498
    10599  size_t row = 0;
     
    125119
    126120    // check number of columns parsed
    127     ASSERT(line_of_values.size() == columns,
     121    ASSERT(line_of_values.size() == getColumns(),
    128122        "MatrixContent::MatrixContent() - row "
    129123        +toString(row)+" has a different number of columns "
    130124        +toString(line_of_values.size())+" than others before "
    131         +toString(columns)+".");
    132 
    133     for (size_t column = 0; column < columns; ++column)
     125        +toString(getColumns())+".");
     126
     127    for (size_t column = 0; column < getColumns(); ++column)
    134128      set(row, column, line_of_values[column]);
    135129    ++row;
    136130  } while (inputstream.good());
    137131  // check number of rows parsed
    138   ASSERT(row == rows,
     132  ASSERT(row == getRows(),
    139133      "MatrixContent::MatrixContent() - insufficent number of rows "
    140       +toString(row)+" < "+toString(rows)+" read.");
     134      +toString(row)+" < "+toString(getRows())+" read.");
    141135}
    142136
     
    147141 */
    148142MatrixContent::MatrixContent(gsl_matrix *&src) :
    149     rows(src->size1),
    150     columns(src->size2),
     143    MatrixDimension(src->size1,src->size2),
    151144    free_content_on_exit(true)
    152145{
     
    161154 */
    162155MatrixContent::MatrixContent(const MatrixContent &src) :
    163     rows(src.rows),
    164     columns(src.columns),
     156    MatrixDimension(src.getRows(),src.getColumns()),
    165157    free_content_on_exit(true)
    166158{
    167   content = gsl_matrix_alloc(src.rows, src.columns);
     159  content = gsl_matrix_alloc(src.getRows(), src.getColumns());
    168160  gsl_matrix_memcpy(content,src.content);
    169161}
     
    173165 */
    174166MatrixContent::MatrixContent(const MatrixContent *src) :
    175     rows(src->rows),
    176     columns(src->columns),
     167    MatrixDimension(src->getRows(),src->getColumns()),
    177168    free_content_on_exit(true)
    178169{
    179170  ASSERT(src != NULL, "MatrixContent::MatrixContent - pointer to source matrix is NULL!");
    180   content = gsl_matrix_alloc(src->rows, src->columns);
     171  content = gsl_matrix_alloc(src->getRows(), src->getColumns());
    181172  gsl_matrix_memcpy(content,src->content);
    182173}
     
    190181}
    191182
    192 /** Getter for MatrixContent::rows.
    193  * \return MatrixContent::rows
    194  */
    195 const size_t MatrixContent::getRows() const
    196 {
    197   return rows;
    198 }
    199 
    200 /** Getter for MatrixContent::columns.
    201  * \return MatrixContent::columns
    202  */
    203 const size_t MatrixContent::getColumns() const
    204 {
    205   return columns;
    206 }
    207 
    208183/** Return a VectorViewContent of the \a column -th column vector.
    209184 *
     
    213188VectorContent *MatrixContent::getColumnVector(size_t column) const
    214189{
    215   ASSERT(column < columns,
     190  ASSERT(column < getColumns(),
    216191      "MatrixContent::getColumnVector() - requested column "+toString(column)
    217       +" greater than dimension "+toString(columns));
     192      +" greater than dimension "+toString(getColumns()));
    218193  return (new VectorViewContent(gsl_matrix_column(content,column)));
    219194}
     
    225200VectorContent *MatrixContent::getRowVector(size_t row) const
    226201{
    227   ASSERT(row < rows,
     202  ASSERT(row < getRows(),
    228203      "MatrixContent::getColumnVector() - requested row "+toString(row)
    229       +" greater than dimension "+toString(rows));
     204      +" greater than dimension "+toString(getRows()));
    230205  return (new VectorViewContent(gsl_matrix_row(content,row)));
    231206}
     
    243218void MatrixContent::setIdentity()
    244219{
    245   for(int i=rows;i--;){
    246     for(int j=columns;j--;){
     220  for(int i=getRows();i--;){
     221    for(int j=getColumns();j--;){
    247222      set(i,j,(double)(i==j));
    248223    }
     
    254229void MatrixContent::setZero()
    255230{
    256   for(int i=rows;i--;){
    257     for(int j=columns;j--;){
     231  for(int i=getRows();i--;){
     232    for(int j=getColumns();j--;){
    258233      set(i,j,0.);
    259234    }
     
    266241void MatrixContent::setValue(double _value)
    267242{
    268   for(int i=rows;i--;){
    269     for(int j=columns;j--;){
     243  for(int i=getRows();i--;){
     244    for(int j=getColumns();j--;){
    270245      set(i,j,_value);
    271246    }
     
    312287const MatrixContent &MatrixContent::operator*=(const MatrixContent &rhs)
    313288{
    314   ASSERT(rhs.columns == rhs.rows,
    315       "MatrixContent::operator*=() - rhs matrix is not square: "+toString(rhs.columns)+" != "+toString(rhs.rows)+".");
    316   ASSERT(columns == rhs.rows,
    317       "MatrixContent::operator*=() - columns dimension differ: "+toString(columns)+" != "+toString(rhs.rows)+".");
     289  ASSERT(rhs.getColumns() == rhs.getRows(),
     290      "MatrixContent::operator*=() - rhs matrix is not square: "+toString(rhs.getColumns())+" != "+toString(rhs.getRows())+".");
     291  ASSERT(getColumns() == rhs.getRows(),
     292      "MatrixContent::operator*=() - columns dimension differ: "+toString(getColumns())+" != "+toString(rhs.getRows())+".");
    318293  (*this) = (*this)*rhs;
    319294  return *this;
     
    326301const MatrixContent MatrixContent::operator*(const MatrixContent &rhs) const
    327302{
    328   ASSERT (columns == rhs.rows,
     303  ASSERT (getColumns() == rhs.getRows(),
    329304      "MatrixContent::operator*() - dimensions not match for matrix product (a,b)*(b,c) = (a,c):"
    330       "("+toString(rows)+","+toString(columns)+")*("+toString(rhs.rows)+","+toString(rhs.columns)+")");
    331   gsl_matrix *res = gsl_matrix_alloc(rows, rhs.columns);
     305      "("+toString(getRows())+","+toString(getColumns())+")*("+toString(rhs.getRows())+","+toString(rhs.getColumns())+")");
     306  gsl_matrix *res = gsl_matrix_alloc(getRows(), rhs.getColumns());
    332307  gsl_blas_dgemm(CblasNoTrans, CblasNoTrans, 1.0, content, rhs.content, 0.0, res);
    333308  // gsl_matrix is taken over by constructor, hence no free
     
    344319const MatrixContent MatrixContent::operator&(const MatrixContent &rhs) const
    345320{
    346   ASSERT ((rows == rhs.rows) && (columns == rhs.columns),
     321  ASSERT ((getRows() == rhs.getRows()) && (getColumns() == rhs.getColumns()),
    347322      "MatrixContent::operator&() - dimensions not match for matrix product (a,b) != (b,c):"
    348       "("+toString(rows)+","+toString(columns)+") != ("+toString(rhs.rows)+","+toString(rhs.columns)+")");
    349   gsl_matrix *res = gsl_matrix_alloc(rows, rhs.columns);
    350   for (size_t i=0;i<rows;++i)
    351     for (size_t j=0;j<columns;++j)
     323      "("+toString(getRows())+","+toString(getColumns())+") != ("+toString(rhs.getRows())+","+toString(rhs.getColumns())+")");
     324  gsl_matrix *res = gsl_matrix_alloc(getRows(), rhs.getColumns());
     325  for (size_t i=0;i<getRows();++i)
     326    for (size_t j=0;j<getColumns();++j)
    352327      gsl_matrix_set(res, i,j, gsl_matrix_get(content, i,j)*gsl_matrix_get(rhs.content, i,j));
    353328  // gsl_matrix is taken over by constructor, hence no free
     
    367342const MatrixContent &MatrixContent::operator&=(const MatrixContent &rhs)
    368343{
    369   ASSERT ((rows == rhs.rows) && (columns == rhs.columns),
     344  ASSERT ((getRows() == rhs.getRows()) && (getColumns() == rhs.getColumns()),
    370345      "MatrixContent::operator&() - dimensions not match for matrix product (a,b) != (b,c):"
    371       "("+toString(rows)+","+toString(columns)+") != ("+toString(rhs.rows)+","+toString(rhs.columns)+")");
    372   for (size_t i=0;i<rows;++i)
    373     for (size_t j=0;j<columns;++j)
     346      "("+toString(getRows())+","+toString(getColumns())+") != ("+toString(rhs.getRows())+","+toString(rhs.getColumns())+")");
     347  for (size_t i=0;i<getRows();++i)
     348    for (size_t j=0;j<getColumns();++j)
    374349      gsl_matrix_set(content, i,j, gsl_matrix_get(content, i,j)*gsl_matrix_get(rhs.content, i,j));
    375350  return *this;
     
    385360double &MatrixContent::at(size_t i, size_t j)
    386361{
    387   ASSERT((i>=0) && (i<rows),
    388       "MatrixContent::at() - Index i="+toString(i)+" for Matrix access out of range [0,"+toString(rows)+"]");
    389   ASSERT((j>=0) && (j<columns),
    390       "MatrixContent::at() - Index j="+toString(j)+" for Matrix access out of range [0,"+toString(columns)+"]");
     362  ASSERT((i>=0) && (i<getRows()),
     363      "MatrixContent::at() - Index i="+toString(i)+" for Matrix access out of range [0,"+toString(getRows())+"]");
     364  ASSERT((j>=0) && (j<getColumns()),
     365      "MatrixContent::at() - Index j="+toString(j)+" for Matrix access out of range [0,"+toString(getColumns())+"]");
    391366  return *gsl_matrix_ptr (content, i, j);
    392367}
     
    399374const double MatrixContent::at(size_t i, size_t j) const
    400375{
    401   ASSERT((i>=0) && (i<rows),
    402       "MatrixContent::at() - Index i="+toString(i)+" for Matrix access out of range [0,"+toString(rows)+"]");
    403   ASSERT((j>=0) && (j<columns),
    404       "MatrixContent::at() - Index j="+toString(j)+" for Matrix access out of range [0,"+toString(columns)+"]");
     376  ASSERT((i>=0) && (i<getRows()),
     377      "MatrixContent::at() - Index i="+toString(i)+" for Matrix access out of range [0,"+toString(getRows())+"]");
     378  ASSERT((j>=0) && (j<getColumns()),
     379      "MatrixContent::at() - Index j="+toString(j)+" for Matrix access out of range [0,"+toString(getColumns())+"]");
    405380  return gsl_matrix_get(content, i, j);
    406381}
     
    435410void MatrixContent::set(size_t i, size_t j, const double value)
    436411{
    437   ASSERT((i>=0) && (i<rows),
    438       "MatrixContent::set() - Index i="+toString(i)+" for Matrix access out of range [0,"+toString(rows)+"]");
    439   ASSERT((j>=0) && (j<columns),
    440       "MatrixContent::set() - Index j="+toString(j)+" for Matrix access out of range [0,"+toString(columns)+"]");
     412  ASSERT((i>=0) && (i<getRows()),
     413      "MatrixContent::set() - Index i="+toString(i)+" for Matrix access out of range [0,"+toString(getRows())+"]");
     414  ASSERT((j>=0) && (j<getColumns()),
     415      "MatrixContent::set() - Index j="+toString(j)+" for Matrix access out of range [0,"+toString(getColumns())+"]");
    441416  gsl_matrix_set(content,i,j,value);
    442417}
     
    448423void MatrixContent::setFromDoubleArray(double * x)
    449424{
    450   gsl_matrix_view m = gsl_matrix_view_array (x, rows, columns);
     425  gsl_matrix_view m = gsl_matrix_view_array (x, getRows(), getColumns());
    451426  gsl_matrix_memcpy (content, &m.matrix);
    452427};
     
    478453bool MatrixContent::SwapRowColumn(size_t i, size_t j)
    479454{
    480   ASSERT (rows == columns,
     455  ASSERT (getRows() == getColumns(),
    481456      "MatrixContent::SwapRowColumn() - The matrix must be square for swapping row against column to be possible.");
    482457  return (gsl_matrix_swap_rowcol (content, i, j) == GSL_SUCCESS);
     
    488463MatrixContent MatrixContent::transposed() const
    489464{
    490   gsl_matrix *res = gsl_matrix_alloc(columns, rows);  // column and row dimensions exchanged!
     465  gsl_matrix *res = gsl_matrix_alloc(getColumns(), getRows());  // column and row dimensions exchanged!
    491466  gsl_matrix_transpose_memcpy(res, content);
    492467  MatrixContent newContent(res);
     
    500475MatrixContent &MatrixContent::transpose()
    501476{
    502   ASSERT( rows == columns,
    503       "MatrixContent::transpose() - cannot transpose onto itself as matrix not square: "+toString(rows)+"!="+toString(columns)+"!");
     477  ASSERT( getRows() == getColumns(),
     478      "MatrixContent::transpose() - cannot transpose onto itself as matrix not square: "+toString(getRows())+"!="+toString(getColumns())+"!");
    504479  double tmp;
    505   for (size_t i=0;i<rows;i++)
    506     for (size_t j=i+1;j<rows;j++) {
     480  for (size_t i=0;i<getRows();i++)
     481    for (size_t j=i+1;j<getRows();j++) {
    507482      tmp = at(j,i);
    508483      at(j,i) = at(i,j);
     
    519494 *  -# V is a NxN orthogonal, square matrix.
    520495 *
    521  * The SVD is only done if MatrixContent::rows is larger equal to MatrixContent::columns, i.e.
     496 * The SVD is only done if MatrixDimension::rows is larger equal to MatrixDimension::columns, i.e.
    522497 * N >= M.
    523498 *
     
    529504void MatrixContent::performSingularValueDecomposition(MatrixContent &V, VectorContent &S)
    530505{
    531   ASSERT(rows >= columns,
     506  ASSERT(getRows() >= getColumns(),
    532507      "MatrixContent::performSingularValueDecomposition() - row count "
    533       +toString(rows)+" must be larger than or equal to column count "+toString(columns)+".");
     508      +toString(getRows())+" must be larger than or equal to column count "+toString(getColumns())+".");
    534509  ASSERT(V.getRows() == V.getColumns(),
    535510      "MatrixContent::performSingularValueDecomposition() - Matrix V must be square!");
    536   ASSERT(V.getRows() == columns,
     511  ASSERT(V.getRows() == getColumns(),
    537512      "MatrixContent::performSingularValueDecomposition() - Given matrix V does not have the right dimension "
    538       +toString(V.getRows())+"!="+toString(rows)+".");
    539   ASSERT(S.getDimension() == columns,
     513      +toString(V.getRows())+"!="+toString(getRows())+".");
     514  ASSERT(S.getDimension() == getColumns(),
    540515      "MatrixContent::performSingularValueDecomposition() - Vector S does not have the right dimension "
    541       +toString(S.getDimension())+"!="+toString(columns)+".");
     516      +toString(S.getDimension())+"!="+toString(getColumns())+".");
    542517  gsl_matrix *A = content;
    543   gsl_vector *work = gsl_vector_alloc(columns);
     518  gsl_vector *work = gsl_vector_alloc(getColumns());
    544519  gsl_linalg_SV_decomp(A,V.content,S.content,work);
    545520  gsl_vector_free(work);
     
    548523/** Performs a SVD on the contained matrix and solves the linear system \f$Ax=b\f$ with given \a b.
    549524 *
    550  * The SVD is only done if MatrixContent::rows is larger equal to MatrixContent::columns.
     525 * The SVD is only done if MatrixDimension::rows is larger equal to MatrixDimension::columns.
    551526 *
    552527 * \note The matrix content is overwritten in the process.
     
    559534VectorContent MatrixContent::solveOverdeterminedLinearEquation(MatrixContent &V, VectorContent &S, const VectorContent &b)
    560535{
    561   ASSERT(b.getDimension() == rows,
     536  ASSERT(b.getDimension() == getRows(),
    562537      "MatrixContent::performSingularValueDecomposition() - Given vector b does not have the right dimension "
    563       +toString(b.getDimension())+"!="+toString(rows)+".");
     538      +toString(b.getDimension())+"!="+toString(getRows())+".");
    564539  ASSERT(V.getRows() == V.getColumns(),
    565540      "MatrixContent::performSingularValueDecomposition() - Matrix V must be square!");
    566   ASSERT(V.getRows() == columns,
     541  ASSERT(V.getRows() == getColumns(),
    567542      "MatrixContent::performSingularValueDecomposition() - Given matrix V does not have the right dimension "
    568       +toString(V.getRows())+"!="+toString(rows)+".");
    569   ASSERT(S.getDimension() == columns,
     543      +toString(V.getRows())+"!="+toString(getRows())+".");
     544  ASSERT(S.getDimension() == getColumns(),
    570545      "MatrixContent::performSingularValueDecomposition() - Vector S does not haver the right dimension "
    571       +toString(S.getDimension())+"!="+toString(columns)+".");
    572 
    573   gsl_vector *x = gsl_vector_alloc(columns);
     546      +toString(S.getDimension())+"!="+toString(getColumns())+".");
     547
     548  gsl_vector *x = gsl_vector_alloc(getColumns());
    574549  gsl_linalg_SV_solve(content,V.content,S.content,b.content,x);
    575550  return VectorContent(x, true);
     
    578553/** Performs a SVD on the contained matrix and solves the linear system \f$Ax=b\f$ with given \a b.
    579554 *
    580  * The SVD is only done if MatrixContent::rows is larger equal to MatrixContent::columns.
     555 * The SVD is only done if MatrixDimension::rows is larger equal to MatrixDimension::columns.
    581556 *
    582557 * \note The matrix content is overwritten in the process.
     
    587562VectorContent MatrixContent::solveOverdeterminedLinearEquation(const VectorContent &b)
    588563{
    589   ASSERT(b.getDimension() == rows,
     564  ASSERT(b.getDimension() == getRows(),
    590565      "MatrixContent::performSingularValueDecomposition() - Given vector b does not have the right dimension "
    591       +toString(b.getDimension())+"!="+toString(rows)+".");
    592   MatrixContent V(columns, columns);
    593   VectorContent S(columns);
     566      +toString(b.getDimension())+"!="+toString(getRows())+".");
     567  MatrixContent V(getColumns(), getColumns());
     568  VectorContent S(getColumns());
    594569  performSingularValueDecomposition(V,S);
    595570  return solveOverdeterminedLinearEquation(V,S,b);
     
    604579gsl_vector* MatrixContent::transformToEigenbasis()
    605580{
    606   if (rows == columns) { // symmetric
    607     gsl_eigen_symmv_workspace *T = gsl_eigen_symmv_alloc(rows);
    608     gsl_vector *eval = gsl_vector_alloc(rows);
    609     gsl_matrix *evec = gsl_matrix_alloc(rows, rows);
     581  if (getRows() == getColumns()) { // symmetric
     582    gsl_eigen_symmv_workspace *T = gsl_eigen_symmv_alloc(getRows());
     583    gsl_vector *eval = gsl_vector_alloc(getRows());
     584    gsl_matrix *evec = gsl_matrix_alloc(getRows(), getRows());
    610585    gsl_eigen_symmv(content, eval, evec, T);
    611586    gsl_eigen_symmv_free(T);
     
    615590  } else { // non-symmetric
    616591    // blow up gsl_matrix in content to square matrix, fill other components with zero
    617     const size_t greaterDimension = rows > columns ? rows : columns;
     592    const size_t greaterDimension = getRows() > getColumns() ? getRows() : getColumns();
    618593    gsl_matrix *content_square = gsl_matrix_alloc(greaterDimension, greaterDimension);
    619594    for (size_t i=0; i<greaterDimension; i++) {
    620595      for (size_t j=0; j<greaterDimension; j++) {
    621         const double value = ((i < rows) && (j < columns)) ? gsl_matrix_get(content,i,j) : 0.;
     596        const double value = ((i < getRows()) && (j < getColumns())) ? gsl_matrix_get(content,i,j) : 0.;
    622597        gsl_matrix_set(content_square, i,j, value);
    623598      }
     
    629604
    630605    // solve eigenvalue problem
    631     gsl_eigen_nonsymmv_workspace *T = gsl_eigen_nonsymmv_alloc(rows);
     606    gsl_eigen_nonsymmv_workspace *T = gsl_eigen_nonsymmv_alloc(getRows());
    632607    gsl_vector_complex *eval = gsl_vector_complex_alloc(greaterDimension);
    633608    gsl_matrix_complex *evec = gsl_matrix_complex_alloc(greaterDimension, greaterDimension);
     
    656631
    657632    // copy real-parts of complex eigenvalues and eigenvectors (column-wise orientation)
    658     gsl_vector *eval_real = gsl_vector_alloc(columns);
     633    gsl_vector *eval_real = gsl_vector_alloc(getColumns());
    659634    size_t I=0;
    660635    for (size_t i=0; i<greaterDimension; i++) { // only copy real space part
     
    731706bool MatrixContent::IsPositiveDefinite() const
    732707{
    733   if (rows != columns)  // only possible for square matrices.
     708  if (getRows() != getColumns())  // only possible for square matrices.
    734709    return false;
    735710  else
     
    744719{
    745720  int signum = 0;
    746   ASSERT(rows == columns,
     721  ASSERT(getRows() == getColumns(),
    747722      "MatrixContent::Determinant() - determinant can only be calculated for square matrices.");
    748   gsl_permutation *p = gsl_permutation_alloc(rows);
     723  gsl_permutation *p = gsl_permutation_alloc(getRows());
    749724  gsl_linalg_LU_decomp(content, p, &signum);
    750725  gsl_permutation_free(p);
     
    815790void MatrixContent::write(std::ostream &ost) const
    816791{
    817   for (size_t row = 0; row < rows; ++row) {
    818     for (size_t column = 0; column < columns; ++column)
     792  for (size_t row = 0; row < getRows(); ++row) {
     793    for (size_t column = 0; column < getColumns(); ++column)
    819794      ost << at(row, column) << "\t";
    820795    ost << std::endl;
     
    863838MatrixContent const operator+(const MatrixContent& a, const MatrixContent& b)
    864839{
    865   ASSERT(a.rows == b.rows, "MatrixContent::operator+() - row counts have to match: "
    866       +toString(a.rows)+" != "+toString(b.rows)+"!");
    867   ASSERT(a.columns == b.columns, "MatrixContent::operator+() - column counts have to match: "
    868       +toString(a.columns)+" != "+toString(b.columns)+"!");
     840  ASSERT(a.getRows() == b.getRows(), "MatrixContent::operator+() - row counts have to match: "
     841      +toString(a.getRows())+" != "+toString(b.getRows())+"!");
     842  ASSERT(a.getColumns() == b.getColumns(), "MatrixContent::operator+() - column counts have to match: "
     843      +toString(a.getColumns())+" != "+toString(b.getColumns())+"!");
    869844  MatrixContent x(a);
    870845  x += b;
     
    879854MatrixContent const operator-(const MatrixContent& a, const MatrixContent& b)
    880855{
    881   ASSERT(a.rows == b.rows, "MatrixContent::operator+() - row counts have to match: "
    882       +toString(a.rows)+" != "+toString(b.rows)+"!");
    883   ASSERT(a.columns == b.columns, "MatrixContent::operator+() - column counts have to match: "
    884       +toString(a.columns)+" != "+toString(b.columns)+"!");
     856  ASSERT(a.getRows() == b.getRows(), "MatrixContent::operator+() - row counts have to match: "
     857      +toString(a.getRows())+" != "+toString(b.getRows())+"!");
     858  ASSERT(a.getColumns() == b.getColumns(), "MatrixContent::operator+() - column counts have to match: "
     859      +toString(a.getColumns())+" != "+toString(b.getColumns())+"!");
    885860  MatrixContent x(a);
    886861  x -= b;
     
    894869bool MatrixContent::operator==(const MatrixContent &rhs) const
    895870    {
    896   if ((rows == rhs.rows) && (columns == rhs.columns)) {
    897     for(int i=rows;i--;){
    898       for(int j=columns;j--;){
     871  if ((getRows() == rhs.getRows()) && (getColumns() == rhs.getColumns())) {
     872    for(int i=getRows();i--;){
     873      for(int j=getColumns();j--;){
    899874        if(fabs(at(i,j)-rhs.at(i,j))>LINALG_MYEPSILON()){
    900875          return false;
     
    911886{
    912887  ost << "\\begin{pmatrix}";
    913   for (size_t i=0;i<mat.rows;i++) {
    914     for (size_t j=0;j<mat.columns;j++) {
     888  for (size_t i=0;i<mat.getRows();i++) {
     889    for (size_t j=0;j<mat.getColumns();j++) {
    915890      ost << mat.at(i,j) << " ";
    916       if (j != mat.columns-1)
     891      if (j != mat.getColumns()-1)
    917892        ost << "& ";
    918893    }
    919     if (i != mat.rows-1)
     894    if (i != mat.getRows()-1)
    920895      ost << "\\\\ ";
    921896  }
  • LinearAlgebra/src/LinearAlgebra/MatrixContent.hpp

    rc8b17b rc5038e  
    1414#endif
    1515
     16#include "CodePatterns/Assert.hpp"
    1617
    1718/** MatrixContent is a wrapper for gsl_matrix.
     
    4647
    4748class VectorContent;
     49namespace boost {
     50  namespace serialization {
     51    class access;
     52  }
     53}
    4854
    4955/** Dummy structure to create a unique signature.
     
    5258struct MatrixBaseCase{};
    5359
    54 class MatrixContent
     60/** This class safely stores matrix dimensions away.
     61 *
     62 * This way we simulate const-ness of the dimensions while still allowing
     63 * serialization to modify them.
     64 *
     65 */
     66struct MatrixDimension {
     67public:
     68  MatrixDimension(size_t _rows, size_t _columns) : rows(_rows), columns(_columns) {}
     69
     70  size_t getRows() const {return rows;}
     71  size_t getColumns() const {return columns;}
     72
     73private:
     74  void setRows(size_t _rows) {rows = _rows;}
     75  void setColumns(size_t _columns) {columns = _columns;}
     76
     77  friend class boost::serialization::access;
     78  // serialization (due to gsl_vector separate versions needed)
     79  template<class Archive>
     80  void serialize(Archive & ar, const unsigned int version)
     81  {
     82    ar & rows;
     83    ar & columns;
     84  }
     85
     86private:
     87  size_t rows;      // store for internal purposes
     88  size_t columns;  // store for internal purposes
     89};
     90
     91class MatrixContent : public MatrixDimension
    5592{
    5693  friend std::ostream & operator<<(std::ostream &ost, const MatrixContent &mat);
     
    121158  bool operator==(const MatrixContent &rhs) const;
    122159
    123   const size_t getRows() const;
    124   const size_t getColumns() const;
    125 
    126160  VectorContent *getColumnVector(size_t column) const;
    127161  VectorContent *getRowVector(size_t row) const;
     
    136170
    137171  gsl_matrix * content;
    138   const size_t rows;      // store for internal purposes
    139   const size_t columns;  // store for internal purposes
    140172
    141173private:
  • LinearAlgebra/src/LinearAlgebra/MatrixVector_ops.cpp

    rc8b17b rc5038e  
    3636VectorContent const operator*(const VectorContent& vec, const MatrixContent& mat)
    3737{
    38   ASSERT( mat.columns == vec.dimension,
    39       "operator*() - column dimension of matrix ("+toString(mat.columns)
    40       +") and dimension of this vector ("+toString(vec.dimension)+") not equal!");
    41   VectorContent result(mat.rows);
     38  ASSERT( mat.getColumns() == vec.getDimension(),
     39      "operator*() - column dimension of matrix ("+toString(mat.getColumns())
     40      +") and dimension of this vector ("+toString(vec.getDimension())+") not equal!");
     41  VectorContent result(mat.getRows());
    4242  gsl_blas_dgemv( CblasNoTrans, 1.0, mat.content, vec.content, 0.0, result.content);
    4343  return result;
     
    5151VectorContent const operator*(const MatrixContent& mat, const VectorContent& vec)
    5252{
    53   ASSERT( mat.columns == vec.dimension,
    54       "operator*() - column dimension of this matrix ("+toString(mat.columns)
    55       +") and dimension of vector ("+toString(vec.dimension)+") not equal!");
    56   VectorContent result(mat.rows);
     53  ASSERT( mat.getColumns() == vec.getDimension(),
     54      "operator*() - column dimension of this matrix ("+toString(mat.getColumns())
     55      +") and dimension of vector ("+toString(vec.getDimension())+") not equal!");
     56  VectorContent result(mat.getRows());
    5757  gsl_blas_dgemv( CblasNoTrans, 1.0, mat.content, vec.content, 0.0, result.content);
    5858  return result;
  • LinearAlgebra/src/LinearAlgebra/VectorContent.cpp

    rc8b17b rc5038e  
    3737 */
    3838VectorContent::VectorContent(size_t _dim) :
    39     dimension(_dim),
     39    VectorDimension(_dim),
    4040    free_content_on_exit(true)
    4141{
    42   content = gsl_vector_calloc(dimension);
     42  content = gsl_vector_calloc(getDimension());
    4343}
    4444
     
    5151 */
    5252VectorContent::VectorContent(VectorBaseCase) :
     53    VectorDimension(0),
    5354    free_content_on_exit(false)
    5455{}
     
    5960 */
    6061VectorContent::VectorContent(const VectorContent * const src) :
    61     dimension(src->dimension),
     62    VectorDimension(src->getDimension()),
    6263    free_content_on_exit(true)
    6364{
    64   content = gsl_vector_alloc(dimension);
     65  content = gsl_vector_alloc(getDimension());
    6566  gsl_vector_memcpy (content, src->content);
    6667};
     
    7172 */
    7273VectorContent::VectorContent(const VectorContent & src) :
    73     dimension(src.dimension),
     74    VectorDimension(src.getDimension()),
    7475    free_content_on_exit(true)
    7576{
    76   content = gsl_vector_alloc(dimension);
     77  content = gsl_vector_alloc(getDimension());
    7778  gsl_vector_memcpy (content, src.content);
    7879};
     
    8485 */
    8586VectorContent::VectorContent(const size_t _dimension, std::istream &inputstream) :
    86   dimension(_dimension),
     87  VectorDimension(_dimension),
    8788  content(NULL),
    8889  free_content_on_exit(true)
    8990{
    9091   // allocate vector and set contents
    91   content = gsl_vector_alloc(dimension);
     92  content = gsl_vector_alloc(getDimension());
    9293
    9394  size_t row = 0;
     
    114115
    115116    // check number of columns parsed
    116     ASSERT(line_of_values.size()+index <= dimension,
     117    ASSERT(line_of_values.size()+index <= getDimension(),
    117118        "VectorContent::VectorContent() - exceedingly many entries in row "
    118119        +toString(row)+": current number is "
    119120        +toString(index)+" and expecting now "
    120         +toString(line_of_values.size())+" which exceeds "+toString(dimension)+".");
     121        +toString(line_of_values.size())+" which exceeds "+toString(getDimension())+".");
    121122
    122123    for (std::vector<double>::const_iterator iter = line_of_values.begin();
     
    126127  } while (inputstream.good());
    127128  // check number of rows parsed
    128   ASSERT(index == dimension,
     129  ASSERT(index == getDimension(),
    129130      "VectorContent::VectorContent() - insufficent number of components "
    130       +toString(index)+" < "+toString(dimension)+" read.");
     131      +toString(index)+" < "+toString(getDimension())+" read.");
    131132}
    132133
     
    138139 */
    139140VectorContent::VectorContent(gsl_vector * _src, bool _free_content_on_exit) :
    140   dimension(_src->size),
     141  VectorDimension(_src->size),
    141142  free_content_on_exit(_free_content_on_exit)
    142143{
     
    163164double &VectorContent::at(size_t i)
    164165{
    165   ASSERT((i>=0) && (i<dimension),
    166       "VectorContent::at() - Index i="+toString(i)+" for Matrix access out of range [0,"+toString(dimension)+"]");
     166  ASSERT((i>=0) && (i<getDimension()),
     167      "VectorContent::at() - Index i="+toString(i)+" for Matrix access out of range [0,"+toString(getDimension())+"]");
    167168  return *gsl_vector_ptr (content, i);
    168169}
     
    174175const double VectorContent::at(size_t i) const
    175176{
    176   ASSERT((i>=0) && (i<dimension),
    177       "VectorContent::at() - Index i="+toString(i)+" for Matrix access out of range [0,"+toString(dimension)+"]");
     177  ASSERT((i>=0) && (i<getDimension()),
     178      "VectorContent::at() - Index i="+toString(i)+" for Matrix access out of range [0,"+toString(getDimension())+"]");
    178179  return gsl_vector_get(content, i);
    179180}
    180181
    181182/** These functions return a pointer to the \a m-th element of a vector.
    182  *  If \a m lies outside the allowed range of 0 to VectorContent::dimension-1 then the error handler is invoked and a null pointer is returned.
     183 *  If \a m lies outside the allowed range of 0 to VectorDimension::dimension-1 then the error handler is invoked and a null pointer is returned.
    183184 * \param m m-th element
    184185 * \return pointer to \a m-th element
     
    190191
    191192/** These functions return a constant pointer to the \a m-th element of a vector.
    192  *  If \a m lies outside the allowed range of 0 to VectorContent::dimension-1 then the error handler is invoked and a null pointer is returned.
     193 *  If \a m lies outside the allowed range of 0 to VectorDimension::dimension-1 then the error handler is invoked and a null pointer is returned.
    193194 * \param m m-th element
    194195 * \return const pointer to \a m-th element
     
    205206VectorContent& VectorContent::operator=(const VectorContent& src)
    206207{
    207   ASSERT(dimension == src.dimension,
     208  ASSERT(getDimension() == src.getDimension(),
    208209      "Dimensions have to be the same to assign VectorContent onto another:"
    209       +toString(dimension)+" != "+toString(src.dimension)+"!");
     210      +toString(getDimension())+" != "+toString(src.getDimension())+"!");
    210211  // check for self assignment
    211212  if(&src!=this){
     
    230231void VectorContent::setFromDoubleArray(double * x)
    231232{
    232   gsl_vector_view m = gsl_vector_view_array (x, dimension);
     233  gsl_vector_view m = gsl_vector_view_array (x, getDimension());
    233234  gsl_vector_memcpy (content, &m.vector);
    234235};
     
    285286double &VectorContent::operator[](size_t i)
    286287{
    287   ASSERT((i>=0) && (i<dimension),
    288       "VectorContent::operator[]() - Index i="+toString(i)+" for Matrix access out of range [0,"+toString(dimension)+"]");
     288  ASSERT((i>=0) && (i<getDimension()),
     289      "VectorContent::operator[]() - Index i="+toString(i)+" for Matrix access out of range [0,"+toString(getDimension())+"]");
    289290  return *gsl_vector_ptr (content, i);
    290291}
     
    296297const double VectorContent::operator[](size_t i) const
    297298{
    298   ASSERT((i>=0) && (i<dimension),
    299       "VectorContent::operator[]() - Index i="+toString(i)+" for Matrix access out of range [0,"+toString(dimension)+"]");
     299  ASSERT((i>=0) && (i<getDimension()),
     300      "VectorContent::operator[]() - Index i="+toString(i)+" for Matrix access out of range [0,"+toString(getDimension())+"]");
    300301  return gsl_vector_get(content, i);
    301302}
     
    310311{
    311312  bool status = true;
    312   ASSERT(dimension == b.dimension, "Dimenions of VectorContents to compare differ");
    313   for (size_t i=0;i<dimension;i++)
     313  ASSERT(getDimension() == b.getDimension(),
     314      "VectorContent::operator==() - Dimensions of VectorContents to compare differ: "
     315      +toString(getDimension())+" != "+toString(b.getDimension())+".");
     316  for (size_t i=0;i<getDimension();i++)
    314317    status = status && (fabs(at(i) - b.at(i)) <= LINALG_MYEPSILON());
    315318  return status;
     
    323326const VectorContent& VectorContent::operator+=(const VectorContent& b)
    324327{
    325   ASSERT(dimension == b.dimension, "Dimenions of VectorContents to compare differ");
    326   for (size_t i=0;i<dimension;i++)
     328  ASSERT(getDimension() == b.getDimension(),
     329      "VectorContent::operator=+() - Dimensions of VectorContents to compare differ: "
     330      +toString(getDimension())+" != "+toString(b.getDimension())+".");
     331  for (size_t i=0;i<getDimension();i++)
    327332    at(i) = at(i)+b.at(i);
    328333  return *this;
     
    336341const VectorContent& VectorContent::operator-=(const VectorContent& b)
    337342{
    338   ASSERT(dimension == b.dimension, "Dimenions of VectorContents to compare differ");
    339   for (size_t i=0;i<dimension;i++)
     343  ASSERT(getDimension() == b.getDimension(),
     344      "VectorContent::operator-=() - Dimensions of VectorContents to compare differ: "
     345      +toString(getDimension())+" != "+toString(b.getDimension())+".");
     346  for (size_t i=0;i<getDimension();i++)
    340347    at(i) = at(i)-b.at(i);
    341348  return *this;
     
    349356const VectorContent& VectorContent::operator*=(const double m)
    350357{
    351   for (size_t i=0;i<dimension;i++)
     358  for (size_t i=0;i<getDimension();i++)
    352359    at(i) = at(i)*m;
    353360  return *this;
     
    361368VectorContent const operator+(const VectorContent& a, const VectorContent& b)
    362369{
    363   ASSERT(a.dimension == b.dimension, "VectorContent::operator+() - dimensions have to match: "+toString(a.dimension)+" != "+toString(b.dimension)+"!");
     370  ASSERT(a.getDimension() == b.getDimension(),
     371      "VectorContent::operator+() - dimensions have to match: "
     372      +toString(a.getDimension())+" != "+toString(b.getDimension())+"!");
    364373  VectorContent x(a);
    365   for (size_t i=0;i<a.dimension;i++)
     374  for (size_t i=0;i<a.getDimension();i++)
    366375    x.at(i) = a.at(i)+b.at(i);
    367376  return x;
     
    375384VectorContent const operator-(const VectorContent& a, const VectorContent& b)
    376385{
    377   ASSERT(a.dimension == b.dimension, "VectorContent::operator-() - dimensions have to match: "+toString(a.dimension)+" != "+toString(b.dimension)+"!");
     386  ASSERT(a.getDimension() == b.getDimension(),
     387      "VectorContent::operator-() - dimensions have to match: "
     388      +toString(a.getDimension())+" != "+toString(b.getDimension())+"!");
    378389  VectorContent x(a);
    379   for (size_t i=0;i<a.dimension;i++)
     390  for (size_t i=0;i<a.getDimension();i++)
    380391    x.at(i) = a.at(i)-b.at(i);
    381392  return x;
     
    390401{
    391402  VectorContent x(a);
    392   for (size_t i=0;i<a.dimension;i++)
     403  for (size_t i=0;i<a.getDimension();i++)
    393404    x.at(i) = a.at(i)*m;
    394405  return x;
     
    403414{
    404415  VectorContent x(a);
    405   for (size_t i=0;i<a.dimension;i++)
     416  for (size_t i=0;i<a.getDimension();i++)
    406417    x.at(i) = a.at(i)*m;
    407418  return x;
     
    411422{
    412423  ost << "[";
    413   for (size_t i=0;i<m.dimension;i++) {
     424  for (size_t i=0;i<m.getDimension();i++) {
    414425    ost << m.at(i);
    415     if (i != m.dimension-1)
     426    if (i != m.getDimension()-1)
    416427      ost << " ";
    417428  }
     
    429440{
    430441  double result = 0.;
    431   for (size_t i = dimension; i--; )
     442  for (size_t i = getDimension(); i--; )
    432443    result += fabs(at(i));
    433444  return (result <= LINALG_MYEPSILON());
     
    440451{
    441452  double NormValue = 0.;
    442   for (size_t i=dimension;--i;)
     453  for (size_t i=getDimension();--i;)
    443454    NormValue += at(i)*at(i);
    444455  return (fabs(NormValue - 1.) <= LINALG_MYEPSILON());
     
    484495{
    485496  double res = 0.;
    486   for (int i=dimension;i--;)
     497  for (int i=getDimension();i--;)
    487498    res += (at(i)-y[i])*(at(i)-y[i]);
    488499  return (res);
     
    570581void VectorContent::write(std::ostream &ost) const
    571582{
    572   for (size_t index = 0; index < dimension; ++index)
     583  for (size_t index = 0; index < getDimension(); ++index)
    573584    ost << at(index) << "\t";
    574585  ost << std::endl;
     
    587598  return res;
    588599};
    589 
    590 /** Getter for VectorContent::dimension.
    591  * @return VectorContent::dimension
    592  */
    593 const size_t VectorContent::getDimension() const
    594 {
    595   return dimension;
    596 }
  • LinearAlgebra/src/LinearAlgebra/VectorContent.hpp

    rc8b17b rc5038e  
    1414#endif
    1515
     16#include "CodePatterns/Assert.hpp"
    1617
    1718/**
     
    3233class Vector;
    3334class MatrixContent;
     35struct VectorViewContent;
     36namespace boost {
     37  namespace serialization {
     38    class access;
     39  }
     40}
     41
     42/** This class safely stores vector dimension away.
     43 *
     44 * This way we simulate const-ness of the dimension while still allowing
     45 * serialization to modify them.
     46 *
     47 */
     48struct VectorDimension {
     49  friend struct VectorViewContent;
     50public:
     51  VectorDimension(size_t _dimension) : dimension(_dimension) {}
     52
     53  size_t getDimension() const {return dimension;}
     54
     55private:
     56  void setDim(size_t _dimension) {dimension = _dimension;}
     57
     58  friend class boost::serialization::access;
     59  // serialization (due to gsl_vector separate versions needed)
     60  template<class Archive>
     61  void serialize(Archive & ar, const unsigned int version)
     62  {
     63    ar & dimension;
     64  }
     65
     66private:
     67  size_t dimension;      // store for internal purposes
     68};
    3469
    3570/** Dummy structure to create a unique signature.
     
    3873struct VectorBaseCase{};
    3974
    40 class VectorContent{
     75class VectorContent : public VectorDimension
     76{
    4177  friend std::ostream & operator<< (std::ostream& ost, const VectorContent &m);
    4278  friend VectorContent const operator*(const VectorContent& a, const double m);
     
    5894  virtual ~VectorContent();
    5995
     96  static size_t preparseVectorDimensions(std::istream &inputstream);
     97
    6098  // Accessing
    6199  double &at(size_t m);
     
    65103  double *Pointer(size_t m) const;
    66104  const double *const_Pointer(size_t m) const;
     105  void write(std::ostream &ost) const;
    67106
    68107  // Assignment operator
     
    106145  const double operator*(const VectorContent& b) const;
    107146
    108   const size_t getDimension() const;
    109 
    110   static size_t preparseVectorDimensions(std::istream &inputstream);
    111   void write(std::ostream &ost) const;
    112 
    113   size_t dimension;
    114147  gsl_vector *content;
    115148private:
Note: See TracChangeset for help on using the changeset viewer.