Changeset c5038e
- Timestamp:
- Oct 12, 2011, 2:10:56 PM (13 years ago)
- 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, 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)
- Location:
- LinearAlgebra/src/LinearAlgebra
- Files:
-
- 6 edited
Legend:
- Unmodified
- Added
- Removed
-
LinearAlgebra/src/LinearAlgebra/LinearSystemOfEquations.cpp
rc8b17b rc5038e 97 97 98 98 // copy solution 99 for (size_t i=0;i<x-> dimension;i++) {99 for (size_t i=0;i<x->getDimension();i++) { 100 100 array[i] = x->at(i); 101 101 } … … 113 113 114 114 // copy solution 115 for (size_t i=0;i<x-> dimension;i++)115 for (size_t i=0;i<x->getDimension();i++) 116 116 v[i] = x->at(i); 117 117 return status; … … 128 128 int s; 129 129 if (IsSymmetric) { // use LU 130 gsl_permutation * p = gsl_permutation_alloc (x-> dimension);130 gsl_permutation * p = gsl_permutation_alloc (x->getDimension()); 131 131 gsl_linalg_LU_decomp (A->content, p, &s); 132 132 gsl_linalg_LU_solve (A->content, p, b->content, x->content); -
LinearAlgebra/src/LinearAlgebra/MatrixContent.cpp
rc8b17b rc5038e 33 33 #include <set> 34 34 35 using namespace std;36 37 35 38 36 /** Constructor for class MatrixContent. … … 41 39 */ 42 40 MatrixContent::MatrixContent(size_t _rows, size_t _columns) : 43 rows(_rows), 44 columns(_columns), 41 MatrixDimension(_rows,_columns), 45 42 free_content_on_exit(true) 46 43 { 47 content = gsl_matrix_calloc( rows, columns);44 content = gsl_matrix_calloc(getRows(), getColumns()); 48 45 } 49 46 … … 56 53 */ 57 54 MatrixContent::MatrixContent(size_t _rows, size_t _columns, MatrixBaseCase) : 58 rows(_rows), 59 columns(_columns), 55 MatrixDimension(_rows,_columns), 60 56 free_content_on_exit(true) 61 57 {} … … 67 63 */ 68 64 MatrixContent::MatrixContent(size_t _rows, size_t _columns, const double *src) : 69 rows(_rows), 70 columns(_columns), 65 MatrixDimension(_rows,_columns), 71 66 free_content_on_exit(true) 72 67 { 73 content = gsl_matrix_calloc( rows, columns);68 content = gsl_matrix_calloc(getRows(), getColumns()); 74 69 set(0,0, src[0]); 75 70 set(1,0, src[1]); … … 95 90 */ 96 91 MatrixContent::MatrixContent(size_t _row, size_t _column, std::istream &inputstream) : 92 MatrixDimension(_row,_column), 97 93 content(NULL), 98 rows(_row),99 columns(_column),100 94 free_content_on_exit(true) 101 95 { 102 96 // allocate matrix and set contents 103 content = gsl_matrix_alloc( rows, columns);97 content = gsl_matrix_alloc(getRows(), getColumns()); 104 98 105 99 size_t row = 0; … … 125 119 126 120 // check number of columns parsed 127 ASSERT(line_of_values.size() == columns,121 ASSERT(line_of_values.size() == getColumns(), 128 122 "MatrixContent::MatrixContent() - row " 129 123 +toString(row)+" has a different number of columns " 130 124 +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) 134 128 set(row, column, line_of_values[column]); 135 129 ++row; 136 130 } while (inputstream.good()); 137 131 // check number of rows parsed 138 ASSERT(row == rows,132 ASSERT(row == getRows(), 139 133 "MatrixContent::MatrixContent() - insufficent number of rows " 140 +toString(row)+" < "+toString( rows)+" read.");134 +toString(row)+" < "+toString(getRows())+" read."); 141 135 } 142 136 … … 147 141 */ 148 142 MatrixContent::MatrixContent(gsl_matrix *&src) : 149 rows(src->size1), 150 columns(src->size2), 143 MatrixDimension(src->size1,src->size2), 151 144 free_content_on_exit(true) 152 145 { … … 161 154 */ 162 155 MatrixContent::MatrixContent(const MatrixContent &src) : 163 rows(src.rows), 164 columns(src.columns), 156 MatrixDimension(src.getRows(),src.getColumns()), 165 157 free_content_on_exit(true) 166 158 { 167 content = gsl_matrix_alloc(src. rows, src.columns);159 content = gsl_matrix_alloc(src.getRows(), src.getColumns()); 168 160 gsl_matrix_memcpy(content,src.content); 169 161 } … … 173 165 */ 174 166 MatrixContent::MatrixContent(const MatrixContent *src) : 175 rows(src->rows), 176 columns(src->columns), 167 MatrixDimension(src->getRows(),src->getColumns()), 177 168 free_content_on_exit(true) 178 169 { 179 170 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()); 181 172 gsl_matrix_memcpy(content,src->content); 182 173 } … … 190 181 } 191 182 192 /** Getter for MatrixContent::rows.193 * \return MatrixContent::rows194 */195 const size_t MatrixContent::getRows() const196 {197 return rows;198 }199 200 /** Getter for MatrixContent::columns.201 * \return MatrixContent::columns202 */203 const size_t MatrixContent::getColumns() const204 {205 return columns;206 }207 208 183 /** Return a VectorViewContent of the \a column -th column vector. 209 184 * … … 213 188 VectorContent *MatrixContent::getColumnVector(size_t column) const 214 189 { 215 ASSERT(column < columns,190 ASSERT(column < getColumns(), 216 191 "MatrixContent::getColumnVector() - requested column "+toString(column) 217 +" greater than dimension "+toString( columns));192 +" greater than dimension "+toString(getColumns())); 218 193 return (new VectorViewContent(gsl_matrix_column(content,column))); 219 194 } … … 225 200 VectorContent *MatrixContent::getRowVector(size_t row) const 226 201 { 227 ASSERT(row < rows,202 ASSERT(row < getRows(), 228 203 "MatrixContent::getColumnVector() - requested row "+toString(row) 229 +" greater than dimension "+toString( rows));204 +" greater than dimension "+toString(getRows())); 230 205 return (new VectorViewContent(gsl_matrix_row(content,row))); 231 206 } … … 243 218 void MatrixContent::setIdentity() 244 219 { 245 for(int i= rows;i--;){246 for(int j= columns;j--;){220 for(int i=getRows();i--;){ 221 for(int j=getColumns();j--;){ 247 222 set(i,j,(double)(i==j)); 248 223 } … … 254 229 void MatrixContent::setZero() 255 230 { 256 for(int i= rows;i--;){257 for(int j= columns;j--;){231 for(int i=getRows();i--;){ 232 for(int j=getColumns();j--;){ 258 233 set(i,j,0.); 259 234 } … … 266 241 void MatrixContent::setValue(double _value) 267 242 { 268 for(int i= rows;i--;){269 for(int j= columns;j--;){243 for(int i=getRows();i--;){ 244 for(int j=getColumns();j--;){ 270 245 set(i,j,_value); 271 246 } … … 312 287 const MatrixContent &MatrixContent::operator*=(const MatrixContent &rhs) 313 288 { 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())+"."); 318 293 (*this) = (*this)*rhs; 319 294 return *this; … … 326 301 const MatrixContent MatrixContent::operator*(const MatrixContent &rhs) const 327 302 { 328 ASSERT ( columns == rhs.rows,303 ASSERT (getColumns() == rhs.getRows(), 329 304 "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()); 332 307 gsl_blas_dgemm(CblasNoTrans, CblasNoTrans, 1.0, content, rhs.content, 0.0, res); 333 308 // gsl_matrix is taken over by constructor, hence no free … … 344 319 const MatrixContent MatrixContent::operator&(const MatrixContent &rhs) const 345 320 { 346 ASSERT (( rows == rhs.rows) && (columns == rhs.columns),321 ASSERT ((getRows() == rhs.getRows()) && (getColumns() == rhs.getColumns()), 347 322 "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) 352 327 gsl_matrix_set(res, i,j, gsl_matrix_get(content, i,j)*gsl_matrix_get(rhs.content, i,j)); 353 328 // gsl_matrix is taken over by constructor, hence no free … … 367 342 const MatrixContent &MatrixContent::operator&=(const MatrixContent &rhs) 368 343 { 369 ASSERT (( rows == rhs.rows) && (columns == rhs.columns),344 ASSERT ((getRows() == rhs.getRows()) && (getColumns() == rhs.getColumns()), 370 345 "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) 374 349 gsl_matrix_set(content, i,j, gsl_matrix_get(content, i,j)*gsl_matrix_get(rhs.content, i,j)); 375 350 return *this; … … 385 360 double &MatrixContent::at(size_t i, size_t j) 386 361 { 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())+"]"); 391 366 return *gsl_matrix_ptr (content, i, j); 392 367 } … … 399 374 const double MatrixContent::at(size_t i, size_t j) const 400 375 { 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())+"]"); 405 380 return gsl_matrix_get(content, i, j); 406 381 } … … 435 410 void MatrixContent::set(size_t i, size_t j, const double value) 436 411 { 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())+"]"); 441 416 gsl_matrix_set(content,i,j,value); 442 417 } … … 448 423 void MatrixContent::setFromDoubleArray(double * x) 449 424 { 450 gsl_matrix_view m = gsl_matrix_view_array (x, rows, columns);425 gsl_matrix_view m = gsl_matrix_view_array (x, getRows(), getColumns()); 451 426 gsl_matrix_memcpy (content, &m.matrix); 452 427 }; … … 478 453 bool MatrixContent::SwapRowColumn(size_t i, size_t j) 479 454 { 480 ASSERT ( rows == columns,455 ASSERT (getRows() == getColumns(), 481 456 "MatrixContent::SwapRowColumn() - The matrix must be square for swapping row against column to be possible."); 482 457 return (gsl_matrix_swap_rowcol (content, i, j) == GSL_SUCCESS); … … 488 463 MatrixContent MatrixContent::transposed() const 489 464 { 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! 491 466 gsl_matrix_transpose_memcpy(res, content); 492 467 MatrixContent newContent(res); … … 500 475 MatrixContent &MatrixContent::transpose() 501 476 { 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())+"!"); 504 479 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++) { 507 482 tmp = at(j,i); 508 483 at(j,i) = at(i,j); … … 519 494 * -# V is a NxN orthogonal, square matrix. 520 495 * 521 * The SVD is only done if Matrix Content::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. 522 497 * N >= M. 523 498 * … … 529 504 void MatrixContent::performSingularValueDecomposition(MatrixContent &V, VectorContent &S) 530 505 { 531 ASSERT( rows >= columns,506 ASSERT(getRows() >= getColumns(), 532 507 "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())+"."); 534 509 ASSERT(V.getRows() == V.getColumns(), 535 510 "MatrixContent::performSingularValueDecomposition() - Matrix V must be square!"); 536 ASSERT(V.getRows() == columns,511 ASSERT(V.getRows() == getColumns(), 537 512 "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(), 540 515 "MatrixContent::performSingularValueDecomposition() - Vector S does not have the right dimension " 541 +toString(S.getDimension())+"!="+toString( columns)+".");516 +toString(S.getDimension())+"!="+toString(getColumns())+"."); 542 517 gsl_matrix *A = content; 543 gsl_vector *work = gsl_vector_alloc( columns);518 gsl_vector *work = gsl_vector_alloc(getColumns()); 544 519 gsl_linalg_SV_decomp(A,V.content,S.content,work); 545 520 gsl_vector_free(work); … … 548 523 /** Performs a SVD on the contained matrix and solves the linear system \f$Ax=b\f$ with given \a b. 549 524 * 550 * The SVD is only done if Matrix Content::rows is larger equal to MatrixContent::columns.525 * The SVD is only done if MatrixDimension::rows is larger equal to MatrixDimension::columns. 551 526 * 552 527 * \note The matrix content is overwritten in the process. … … 559 534 VectorContent MatrixContent::solveOverdeterminedLinearEquation(MatrixContent &V, VectorContent &S, const VectorContent &b) 560 535 { 561 ASSERT(b.getDimension() == rows,536 ASSERT(b.getDimension() == getRows(), 562 537 "MatrixContent::performSingularValueDecomposition() - Given vector b does not have the right dimension " 563 +toString(b.getDimension())+"!="+toString( rows)+".");538 +toString(b.getDimension())+"!="+toString(getRows())+"."); 564 539 ASSERT(V.getRows() == V.getColumns(), 565 540 "MatrixContent::performSingularValueDecomposition() - Matrix V must be square!"); 566 ASSERT(V.getRows() == columns,541 ASSERT(V.getRows() == getColumns(), 567 542 "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(), 570 545 "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()); 574 549 gsl_linalg_SV_solve(content,V.content,S.content,b.content,x); 575 550 return VectorContent(x, true); … … 578 553 /** Performs a SVD on the contained matrix and solves the linear system \f$Ax=b\f$ with given \a b. 579 554 * 580 * The SVD is only done if Matrix Content::rows is larger equal to MatrixContent::columns.555 * The SVD is only done if MatrixDimension::rows is larger equal to MatrixDimension::columns. 581 556 * 582 557 * \note The matrix content is overwritten in the process. … … 587 562 VectorContent MatrixContent::solveOverdeterminedLinearEquation(const VectorContent &b) 588 563 { 589 ASSERT(b.getDimension() == rows,564 ASSERT(b.getDimension() == getRows(), 590 565 "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()); 594 569 performSingularValueDecomposition(V,S); 595 570 return solveOverdeterminedLinearEquation(V,S,b); … … 604 579 gsl_vector* MatrixContent::transformToEigenbasis() 605 580 { 606 if ( rows == columns) { // symmetric607 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()); 610 585 gsl_eigen_symmv(content, eval, evec, T); 611 586 gsl_eigen_symmv_free(T); … … 615 590 } else { // non-symmetric 616 591 // 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(); 618 593 gsl_matrix *content_square = gsl_matrix_alloc(greaterDimension, greaterDimension); 619 594 for (size_t i=0; i<greaterDimension; i++) { 620 595 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.; 622 597 gsl_matrix_set(content_square, i,j, value); 623 598 } … … 629 604 630 605 // 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()); 632 607 gsl_vector_complex *eval = gsl_vector_complex_alloc(greaterDimension); 633 608 gsl_matrix_complex *evec = gsl_matrix_complex_alloc(greaterDimension, greaterDimension); … … 656 631 657 632 // 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()); 659 634 size_t I=0; 660 635 for (size_t i=0; i<greaterDimension; i++) { // only copy real space part … … 731 706 bool MatrixContent::IsPositiveDefinite() const 732 707 { 733 if ( rows != columns) // only possible for square matrices.708 if (getRows() != getColumns()) // only possible for square matrices. 734 709 return false; 735 710 else … … 744 719 { 745 720 int signum = 0; 746 ASSERT( rows == columns,721 ASSERT(getRows() == getColumns(), 747 722 "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()); 749 724 gsl_linalg_LU_decomp(content, p, &signum); 750 725 gsl_permutation_free(p); … … 815 790 void MatrixContent::write(std::ostream &ost) const 816 791 { 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) 819 794 ost << at(row, column) << "\t"; 820 795 ost << std::endl; … … 863 838 MatrixContent const operator+(const MatrixContent& a, const MatrixContent& b) 864 839 { 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())+"!"); 869 844 MatrixContent x(a); 870 845 x += b; … … 879 854 MatrixContent const operator-(const MatrixContent& a, const MatrixContent& b) 880 855 { 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())+"!"); 885 860 MatrixContent x(a); 886 861 x -= b; … … 894 869 bool MatrixContent::operator==(const MatrixContent &rhs) const 895 870 { 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--;){ 899 874 if(fabs(at(i,j)-rhs.at(i,j))>LINALG_MYEPSILON()){ 900 875 return false; … … 911 886 { 912 887 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++) { 915 890 ost << mat.at(i,j) << " "; 916 if (j != mat. columns-1)891 if (j != mat.getColumns()-1) 917 892 ost << "& "; 918 893 } 919 if (i != mat. rows-1)894 if (i != mat.getRows()-1) 920 895 ost << "\\\\ "; 921 896 } -
LinearAlgebra/src/LinearAlgebra/MatrixContent.hpp
rc8b17b rc5038e 14 14 #endif 15 15 16 #include "CodePatterns/Assert.hpp" 16 17 17 18 /** MatrixContent is a wrapper for gsl_matrix. … … 46 47 47 48 class VectorContent; 49 namespace boost { 50 namespace serialization { 51 class access; 52 } 53 } 48 54 49 55 /** Dummy structure to create a unique signature. … … 52 58 struct MatrixBaseCase{}; 53 59 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 */ 66 struct MatrixDimension { 67 public: 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 73 private: 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 86 private: 87 size_t rows; // store for internal purposes 88 size_t columns; // store for internal purposes 89 }; 90 91 class MatrixContent : public MatrixDimension 55 92 { 56 93 friend std::ostream & operator<<(std::ostream &ost, const MatrixContent &mat); … … 121 158 bool operator==(const MatrixContent &rhs) const; 122 159 123 const size_t getRows() const;124 const size_t getColumns() const;125 126 160 VectorContent *getColumnVector(size_t column) const; 127 161 VectorContent *getRowVector(size_t row) const; … … 136 170 137 171 gsl_matrix * content; 138 const size_t rows; // store for internal purposes139 const size_t columns; // store for internal purposes140 172 141 173 private: -
LinearAlgebra/src/LinearAlgebra/MatrixVector_ops.cpp
rc8b17b rc5038e 36 36 VectorContent const operator*(const VectorContent& vec, const MatrixContent& mat) 37 37 { 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()); 42 42 gsl_blas_dgemv( CblasNoTrans, 1.0, mat.content, vec.content, 0.0, result.content); 43 43 return result; … … 51 51 VectorContent const operator*(const MatrixContent& mat, const VectorContent& vec) 52 52 { 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()); 57 57 gsl_blas_dgemv( CblasNoTrans, 1.0, mat.content, vec.content, 0.0, result.content); 58 58 return result; -
LinearAlgebra/src/LinearAlgebra/VectorContent.cpp
rc8b17b rc5038e 37 37 */ 38 38 VectorContent::VectorContent(size_t _dim) : 39 dimension(_dim),39 VectorDimension(_dim), 40 40 free_content_on_exit(true) 41 41 { 42 content = gsl_vector_calloc( dimension);42 content = gsl_vector_calloc(getDimension()); 43 43 } 44 44 … … 51 51 */ 52 52 VectorContent::VectorContent(VectorBaseCase) : 53 VectorDimension(0), 53 54 free_content_on_exit(false) 54 55 {} … … 59 60 */ 60 61 VectorContent::VectorContent(const VectorContent * const src) : 61 dimension(src->dimension),62 VectorDimension(src->getDimension()), 62 63 free_content_on_exit(true) 63 64 { 64 content = gsl_vector_alloc( dimension);65 content = gsl_vector_alloc(getDimension()); 65 66 gsl_vector_memcpy (content, src->content); 66 67 }; … … 71 72 */ 72 73 VectorContent::VectorContent(const VectorContent & src) : 73 dimension(src.dimension),74 VectorDimension(src.getDimension()), 74 75 free_content_on_exit(true) 75 76 { 76 content = gsl_vector_alloc( dimension);77 content = gsl_vector_alloc(getDimension()); 77 78 gsl_vector_memcpy (content, src.content); 78 79 }; … … 84 85 */ 85 86 VectorContent::VectorContent(const size_t _dimension, std::istream &inputstream) : 86 dimension(_dimension),87 VectorDimension(_dimension), 87 88 content(NULL), 88 89 free_content_on_exit(true) 89 90 { 90 91 // allocate vector and set contents 91 content = gsl_vector_alloc( dimension);92 content = gsl_vector_alloc(getDimension()); 92 93 93 94 size_t row = 0; … … 114 115 115 116 // check number of columns parsed 116 ASSERT(line_of_values.size()+index <= dimension,117 ASSERT(line_of_values.size()+index <= getDimension(), 117 118 "VectorContent::VectorContent() - exceedingly many entries in row " 118 119 +toString(row)+": current number is " 119 120 +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())+"."); 121 122 122 123 for (std::vector<double>::const_iterator iter = line_of_values.begin(); … … 126 127 } while (inputstream.good()); 127 128 // check number of rows parsed 128 ASSERT(index == dimension,129 ASSERT(index == getDimension(), 129 130 "VectorContent::VectorContent() - insufficent number of components " 130 +toString(index)+" < "+toString( dimension)+" read.");131 +toString(index)+" < "+toString(getDimension())+" read."); 131 132 } 132 133 … … 138 139 */ 139 140 VectorContent::VectorContent(gsl_vector * _src, bool _free_content_on_exit) : 140 dimension(_src->size),141 VectorDimension(_src->size), 141 142 free_content_on_exit(_free_content_on_exit) 142 143 { … … 163 164 double &VectorContent::at(size_t i) 164 165 { 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())+"]"); 167 168 return *gsl_vector_ptr (content, i); 168 169 } … … 174 175 const double VectorContent::at(size_t i) const 175 176 { 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())+"]"); 178 179 return gsl_vector_get(content, i); 179 180 } 180 181 181 182 /** 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 Vector Content::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. 183 184 * \param m m-th element 184 185 * \return pointer to \a m-th element … … 190 191 191 192 /** 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 Vector Content::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. 193 194 * \param m m-th element 194 195 * \return const pointer to \a m-th element … … 205 206 VectorContent& VectorContent::operator=(const VectorContent& src) 206 207 { 207 ASSERT( dimension == src.dimension,208 ASSERT(getDimension() == src.getDimension(), 208 209 "Dimensions have to be the same to assign VectorContent onto another:" 209 +toString( dimension)+" != "+toString(src.dimension)+"!");210 +toString(getDimension())+" != "+toString(src.getDimension())+"!"); 210 211 // check for self assignment 211 212 if(&src!=this){ … … 230 231 void VectorContent::setFromDoubleArray(double * x) 231 232 { 232 gsl_vector_view m = gsl_vector_view_array (x, dimension);233 gsl_vector_view m = gsl_vector_view_array (x, getDimension()); 233 234 gsl_vector_memcpy (content, &m.vector); 234 235 }; … … 285 286 double &VectorContent::operator[](size_t i) 286 287 { 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())+"]"); 289 290 return *gsl_vector_ptr (content, i); 290 291 } … … 296 297 const double VectorContent::operator[](size_t i) const 297 298 { 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())+"]"); 300 301 return gsl_vector_get(content, i); 301 302 } … … 310 311 { 311 312 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++) 314 317 status = status && (fabs(at(i) - b.at(i)) <= LINALG_MYEPSILON()); 315 318 return status; … … 323 326 const VectorContent& VectorContent::operator+=(const VectorContent& b) 324 327 { 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++) 327 332 at(i) = at(i)+b.at(i); 328 333 return *this; … … 336 341 const VectorContent& VectorContent::operator-=(const VectorContent& b) 337 342 { 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++) 340 347 at(i) = at(i)-b.at(i); 341 348 return *this; … … 349 356 const VectorContent& VectorContent::operator*=(const double m) 350 357 { 351 for (size_t i=0;i< dimension;i++)358 for (size_t i=0;i<getDimension();i++) 352 359 at(i) = at(i)*m; 353 360 return *this; … … 361 368 VectorContent const operator+(const VectorContent& a, const VectorContent& b) 362 369 { 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())+"!"); 364 373 VectorContent x(a); 365 for (size_t i=0;i<a. dimension;i++)374 for (size_t i=0;i<a.getDimension();i++) 366 375 x.at(i) = a.at(i)+b.at(i); 367 376 return x; … … 375 384 VectorContent const operator-(const VectorContent& a, const VectorContent& b) 376 385 { 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())+"!"); 378 389 VectorContent x(a); 379 for (size_t i=0;i<a. dimension;i++)390 for (size_t i=0;i<a.getDimension();i++) 380 391 x.at(i) = a.at(i)-b.at(i); 381 392 return x; … … 390 401 { 391 402 VectorContent x(a); 392 for (size_t i=0;i<a. dimension;i++)403 for (size_t i=0;i<a.getDimension();i++) 393 404 x.at(i) = a.at(i)*m; 394 405 return x; … … 403 414 { 404 415 VectorContent x(a); 405 for (size_t i=0;i<a. dimension;i++)416 for (size_t i=0;i<a.getDimension();i++) 406 417 x.at(i) = a.at(i)*m; 407 418 return x; … … 411 422 { 412 423 ost << "["; 413 for (size_t i=0;i<m. dimension;i++) {424 for (size_t i=0;i<m.getDimension();i++) { 414 425 ost << m.at(i); 415 if (i != m. dimension-1)426 if (i != m.getDimension()-1) 416 427 ost << " "; 417 428 } … … 429 440 { 430 441 double result = 0.; 431 for (size_t i = dimension; i--; )442 for (size_t i = getDimension(); i--; ) 432 443 result += fabs(at(i)); 433 444 return (result <= LINALG_MYEPSILON()); … … 440 451 { 441 452 double NormValue = 0.; 442 for (size_t i= dimension;--i;)453 for (size_t i=getDimension();--i;) 443 454 NormValue += at(i)*at(i); 444 455 return (fabs(NormValue - 1.) <= LINALG_MYEPSILON()); … … 484 495 { 485 496 double res = 0.; 486 for (int i= dimension;i--;)497 for (int i=getDimension();i--;) 487 498 res += (at(i)-y[i])*(at(i)-y[i]); 488 499 return (res); … … 570 581 void VectorContent::write(std::ostream &ost) const 571 582 { 572 for (size_t index = 0; index < dimension; ++index)583 for (size_t index = 0; index < getDimension(); ++index) 573 584 ost << at(index) << "\t"; 574 585 ost << std::endl; … … 587 598 return res; 588 599 }; 589 590 /** Getter for VectorContent::dimension.591 * @return VectorContent::dimension592 */593 const size_t VectorContent::getDimension() const594 {595 return dimension;596 } -
LinearAlgebra/src/LinearAlgebra/VectorContent.hpp
rc8b17b rc5038e 14 14 #endif 15 15 16 #include "CodePatterns/Assert.hpp" 16 17 17 18 /** … … 32 33 class Vector; 33 34 class MatrixContent; 35 struct VectorViewContent; 36 namespace 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 */ 48 struct VectorDimension { 49 friend struct VectorViewContent; 50 public: 51 VectorDimension(size_t _dimension) : dimension(_dimension) {} 52 53 size_t getDimension() const {return dimension;} 54 55 private: 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 66 private: 67 size_t dimension; // store for internal purposes 68 }; 34 69 35 70 /** Dummy structure to create a unique signature. … … 38 73 struct VectorBaseCase{}; 39 74 40 class VectorContent{ 75 class VectorContent : public VectorDimension 76 { 41 77 friend std::ostream & operator<< (std::ostream& ost, const VectorContent &m); 42 78 friend VectorContent const operator*(const VectorContent& a, const double m); … … 58 94 virtual ~VectorContent(); 59 95 96 static size_t preparseVectorDimensions(std::istream &inputstream); 97 60 98 // Accessing 61 99 double &at(size_t m); … … 65 103 double *Pointer(size_t m) const; 66 104 const double *const_Pointer(size_t m) const; 105 void write(std::ostream &ost) const; 67 106 68 107 // Assignment operator … … 106 145 const double operator*(const VectorContent& b) const; 107 146 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;114 147 gsl_vector *content; 115 148 private:
Note:
See TracChangeset
for help on using the changeset viewer.