]> www.ginac.de Git - ginac.git/blobdiff - ginac/matrix.cpp
- introduced info_flag::algebraic.
[ginac.git] / ginac / matrix.cpp
index f219f27de0c3dcb1432bcc7d944b4ef8bcd63dcc..c5d056c205fb002e53defba3a77a225b14945f54 100644 (file)
@@ -30,6 +30,9 @@
 #include "lst.h"
 #include "utils.h"
 #include "debugmsg.h"
+#include "power.h"
+#include "symbol.h"
+#include "normal.h"
 
 #ifndef NO_NAMESPACE_GINAC
 namespace GiNaC {
@@ -78,9 +81,9 @@ const matrix & matrix::operator=(const matrix & other)
 void matrix::copy(const matrix & other)
 {
     inherited::copy(other);
-    row=other.row;
-    col=other.col;
-    m=other.m;  // use STL's vector copying
+    row = other.row;
+    col = other.col;
+    m = other.m;  // STL's vector copying invoked here
 }
 
 void matrix::destroy(bool call_parent)
@@ -105,7 +108,7 @@ matrix::matrix(unsigned r, unsigned c)
     m.resize(r*c, _ex0());
 }
 
-// protected
+ // protected
 
 /** Ctor from representation, for internal use only. */
 matrix::matrix(unsigned r, unsigned c, const exvector & m2)
@@ -378,11 +381,13 @@ matrix matrix::mul(const matrix & other) const
         throw (std::logic_error("matrix::mul(): incompatible matrices"));
     
     exvector prod(row*other.col);
-    for (unsigned i=0; i<row; ++i) {
-        for (unsigned j=0; j<other.col; ++j) {
-            for (unsigned l=0; l<col; ++l) {
-                prod[i*other.col+j] += m[i*col+l] * other.m[l*other.col+j];
-            }
+    
+    for (unsigned r1=0; r1<row; ++r1) {
+        for (unsigned c=0; c<col; ++c) {
+            if (m[r1*col+c].is_zero())
+                continue;
+            for (unsigned r2=0; r2<other.col; ++r2)
+                prod[r1*other.col+r2] += m[r1*col+c] * other.m[c*other.col+r2];
         }
     }
     return matrix(row, other.col, prod);
@@ -455,29 +460,28 @@ ex matrix::determinant(void) const
     bool normal_flag = false;
     unsigned sparse_count = 0;  // count non-zero elements
     for (exvector::const_iterator r=m.begin(); r!=m.end(); ++r) {
-        if (!(*r).is_zero()) {
+        if (!(*r).is_zero())
             ++sparse_count;
-        }
-        if (!(*r).info(info_flags::numeric)) {
+        if (!(*r).info(info_flags::numeric))
             numeric_flag = false;
-        }
         if ((*r).info(info_flags::rational_function) &&
-            !(*r).info(info_flags::crational_polynomial)) {
+            !(*r).info(info_flags::crational_polynomial))
             normal_flag = true;
-        }
     }
     
-    if (numeric_flag)
+    if (numeric_flag)  // purely numeric matrix
         return determinant_numeric();
-    
-    if (5*sparse_count<row*col) {     // MAGIC, maybe 10 some bright day?
-        matrix M(*this);
-        // int sign = M.division_free_elimination();
-        int sign = M.fraction_free_elimination();
+    // Does anybody really know when a matrix is sparse?
+    // Maybe <~row/2.2 nonzero elements average in a row?
+    if (5*sparse_count<=row*col) {
+        // copy *this:
+        matrix tmp(*this);
+        int sign;
+        sign = tmp.fraction_free_elimination(true);
         if (normal_flag)
-            return sign*M(row-1,col-1).normal();
+            return (sign*tmp.m[row*col-1]).normal();
         else
-            return sign*M(row-1,col-1).expand();
+            return (sign*tmp.m[row*col-1]).expand();
     }
     
     // Now come the minor expansion schemes.  We always develop such that the
@@ -510,8 +514,8 @@ ex matrix::determinant(void) const
     }
     
     if (normal_flag)
-        return sign*matrix(row,col,result).determinant_minor_dense().normal();
-    return sign*matrix(row,col,result).determinant_minor_dense();
+        return sign*matrix(row,col,result).determinant_minor().normal();
+    return sign*matrix(row,col,result).determinant_minor();
 }
 
 
@@ -539,24 +543,54 @@ ex matrix::trace(void) const
 }
 
 
-/** Characteristic Polynomial.  The characteristic polynomial of a matrix M is
- *  defined as the determiant of (M - lambda * 1) where 1 stands for the unit
- *  matrix of the same dimension as M.  This method returns the characteristic
- *  polynomial as a new expression.
+/** Characteristic Polynomial.  Following mathematica notation the
+ *  characteristic polynomial of a matrix M is defined as the determiant of
+ *  (M - lambda * 1) where 1 stands for the unit matrix of the same dimension
+ *  as M.  Note that some CASs define it with a sign inside the determinant
+ *  which gives rise to an overall sign if the dimension is odd.  This method
+ *  returns the characteristic polynomial collected in powers of lambda as a
+ *  new expression.
  *
  *  @return    characteristic polynomial as new expression
  *  @exception logic_error (matrix not square)
  *  @see       matrix::determinant() */
-ex matrix::charpoly(const ex & lambda) const
+ex matrix::charpoly(const symbol & lambda) const
 {
     if (row != col)
         throw (std::logic_error("matrix::charpoly(): matrix not square"));
     
+    bool numeric_flag = true;
+    for (exvector::const_iterator r=m.begin(); r!=m.end(); ++r) {
+        if (!(*r).info(info_flags::numeric)) {
+            numeric_flag = false;
+        }
+    }
+    
+    // The pure numeric case is traditionally rather common.  Hence, it is
+    // trapped and we use Leverrier's algorithm which goes as row^3 for
+    // every coefficient.  The expensive part is the matrix multiplication.
+    if (numeric_flag) {
+        matrix B(*this);
+        ex c = B.trace();
+        ex poly = power(lambda,row)-c*power(lambda,row-1);
+        for (unsigned i=1; i<row; ++i) {
+            for (unsigned j=0; j<row; ++j)
+                B.m[j*col+j] -= c;
+            B = this->mul(B);
+            c = B.trace()/ex(i+1);
+            poly -= c*power(lambda,row-i-1);
+        }
+        if (row%2)
+            return -poly;
+        else
+            return poly;
+    }
+    
     matrix M(*this);
     for (unsigned r=0; r<col; ++r)
         M.m[r*col+r] -= lambda;
     
-    return (M.determinant());
+    return M.determinant().collect(lambda);
 }
 
 
@@ -639,7 +673,7 @@ ex matrix::ffe_get(unsigned r, unsigned c) const
 matrix matrix::fraction_free_elim(const matrix & vars,
                                   const matrix & rhs) const
 {
-    // FIXME: implement a Sasaki-Murao scheme which avoids division at all!
+    // FIXME: use implementation of matrix::fraction_free_elimination
     if ((row != rhs.row) || (col != vars.row) || (rhs.col != vars.col))
         throw (std::logic_error("matrix::fraction_free_elim(): incompatible matrices"));
     
@@ -682,18 +716,13 @@ matrix matrix::fraction_free_elim(const matrix & vars,
             divisor = a.ffe_get(r,k);
             r++;
         }
-    }
-    // optionally compute the determinant for square or augmented matrices
-    // if (r==m+1) { det = sign*divisor; } else { det = 0; }
-    
-    /*
-    for (unsigned r=1; r<=m; ++r) {
-        for (unsigned c=1; c<=n; ++c) {
-            cout << a.ffe_get(r,c) << "\t";
-        }
-        cout << " | " <<  b.ffe_get(r,1) << endl;
-    }
-    */
+    }    
+//     for (unsigned r=1; r<=m; ++r) {
+//         for (unsigned c=1; c<=n; ++c) {
+//             cout << a.ffe_get(r,c) << "\t";
+//         }
+//         cout << " | " <<  b.ffe_get(r,1) << endl;
+//     }
     
 #ifdef DO_GINAC_ASSERT
     // test if we really have an upper echelon matrix
@@ -701,7 +730,7 @@ matrix matrix::fraction_free_elim(const matrix & vars,
     for (unsigned r=1; r<=m; ++r) {
         int zero_in_this_row=0;
         for (unsigned c=1; c<=n; ++c) {
-            if (a.ffe_get(r,c).is_equal(_ex0()))
+            if (a.ffe_get(r,c).is_zero())
                zero_in_this_row++;
             else
                 break;
@@ -711,12 +740,6 @@ matrix matrix::fraction_free_elim(const matrix & vars,
     }
 #endif // def DO_GINAC_ASSERT
     
-    /*
-    cout << "after" << endl;
-    cout << "a=" << a << endl;
-    cout << "b=" << b << endl;
-    */
-    
     // assemble solution
     matrix sol(n,1);
     unsigned last_assigned_sol = n+1;
@@ -846,6 +869,7 @@ ex matrix::determinant_numeric(void) const
     ex det = _ex1();
     ex piv;
     
+    // standard Gauss method:
     for (unsigned r1=0; r1<row; ++r1) {
         int indx = tmp.pivot(r1);
         if (indx == -1)
@@ -865,67 +889,6 @@ ex matrix::determinant_numeric(void) const
 }
 
 
-/*  Leverrier algorithm for large matrices having at least one symbolic entry.
- *  This routine is only called internally by matrix::determinant(). The
- *  algorithm is very bad for symbolic matrices since it returns expressions
- *  that are quite hard to expand. */
-/*ex matrix::determinant_leverrier(const matrix & M)
- *{
- *    GINAC_ASSERT(M.rows()==M.cols());  // cannot happen, just in case...
- *    
- *    matrix B(M);
- *    matrix I(M.row, M.col);
- *    ex c=B.trace();
- *    for (unsigned i=1; i<M.row; ++i) {
- *        for (unsigned j=0; j<M.row; ++j)
- *            I.m[j*M.col+j] = c;
- *        B = M.mul(B.sub(I));
- *        c = B.trace()/ex(i+1);
- *    }
- *    if (M.row%2) {
- *        return c;
- *    } else {
- *        return -c;
- *    }
- *}*/
-
-
-ex matrix::determinant_minor_sparse(void) const
-{
-    // for small matrices the algorithm does not make any sense:
-    if (this->row==1)
-        return m[0];
-    if (this->row==2)
-        return (m[0]*m[3]-m[2]*m[1]).expand();
-    if (this->row==3)
-        return (m[0]*m[4]*m[8]-m[0]*m[5]*m[7]-
-                m[1]*m[3]*m[8]+m[2]*m[3]*m[7]+
-                m[1]*m[5]*m[6]-m[2]*m[4]*m[6]).expand();
-    
-    ex det;
-    matrix minorM(this->row-1,this->col-1);
-    for (unsigned r1=0; r1<this->row; ++r1) {
-        // shortcut if element(r1,0) vanishes
-        if (m[r1*col].is_zero())
-            continue;
-        // assemble the minor matrix
-        for (unsigned r=0; r<minorM.rows(); ++r) {
-            for (unsigned c=0; c<minorM.cols(); ++c) {
-                if (r<r1)
-                    minorM.set(r,c,m[r*col+c+1]);
-                else
-                    minorM.set(r,c,m[(r+1)*col+c+1]);
-            }
-        }
-        // recurse down and care for sign:
-        if (r1%2)
-            det -= m[r1*col] * minorM.determinant_minor_sparse();
-        else
-            det += m[r1*col] * minorM.determinant_minor_sparse();
-    }
-    return det.expand();
-}
-
 /** Recursive determinant for small matrices having at least one symbolic
  *  entry.  The basic algorithm, known as Laplace-expansion, is enhanced by
  *  some bookkeeping to avoid calculation of the same submatrices ("minors")
@@ -936,7 +899,7 @@ ex matrix::determinant_minor_sparse(void) const
  *
  *  @return the determinant as a new expression (in expanded form)
  *  @see matrix::determinant() */
-ex matrix::determinant_minor_dense(void) const
+ex matrix::determinant_minor(void) const
 {
     // for small matrices the algorithm does not make any sense:
     if (this->row==1)
@@ -1046,47 +1009,6 @@ ex matrix::determinant_minor_dense(void) const
 }
 
 
-/*  Determinant using a simple Bareiss elimination scheme.  Suited for
- *  sparse matrices.
- *
- *  @return the determinant as a new expression (in expanded form)
- *  @see matrix::determinant() */
-ex matrix::determinant_bareiss(void) const
-{
-    matrix M(*this);
-    int sign = M.fraction_free_elimination();
-    if (sign)
-        return sign*M(row-1,col-1);
-    else
-        return _ex0();
-}
-
-
-/** Determinant built by application of the full permutation group.  This
- *  routine is only called internally by matrix::determinant().
- *  NOTE: it is probably inefficient in all cases and may be eliminated. */
-ex matrix::determinant_perm(void) const
-{
-    if (rows()==1)  // speed things up
-        return m[0];
-    
-    ex det;
-    ex term;
-    vector<unsigned> sigma(col);
-    for (unsigned i=0; i<col; ++i)
-        sigma[i]=i;
-    
-    do {
-        term = (*this)(sigma[0],0);
-        for (unsigned i=1; i<col; ++i)
-            term *= (*this)(sigma[i],i);
-        det += permutation_sign(sigma)*term;
-    } while (next_permutation(sigma.begin(), sigma.end()));
-    
-    return det;
-}
-
-
 /** Perform the steps of an ordinary Gaussian elimination to bring the matrix
  *  into an upper echelon form.
  *
@@ -1142,31 +1064,128 @@ int matrix::division_free_elimination(void)
 
 
 /** Perform the steps of Bareiss' one-step fraction free elimination to bring
- *  the matrix into an upper echelon form.
- *
+ *  the matrix into an upper echelon form.  Fraction free elimination means
+ *  that divide is used straightforwardly, without computing GCDs first.  This
+ *  is possible, since we know the divisor at each step.
+ *  
+ *  @param det may be set to true to save a lot of space if one is only
+ *  interested in the last element (i.e. for calculating determinants), the
+ *  others are set to zero in this case.
  *  @return sign is 1 if an even number of rows was swapped, -1 if an odd
  *  number of rows was swapped and 0 if the matrix is singular. */
-int matrix::fraction_free_elimination(void)
+int matrix::fraction_free_elimination(bool det)
 {
-    int sign = 1;
-    ex divisor = 1;
+    // Method:
+    // (single-step fraction free elimination scheme, already known to Jordan)
+    //
+    // Usual division-free elimination sets m[0](r,c) = m(r,c) and then sets
+    //     m[k+1](r,c) = m[k](k,k) * m[k](r,c) - m[k](r,k) * m[k](k,c).
+    //
+    // Bareiss (fraction-free) elimination in addition divides that element
+    // by m[k-1](k-1,k-1) for k>1, where it can be shown by means of the
+    // Sylvester determinant that this really divides m[k+1](r,c).
+    //
+    // We also allow rational functions where the original prove still holds.
+    // However, we must care for numerator and denominator separately and
+    // "manually" work in the integral domains because of subtle cancellations
+    // (see below).  This blows up the bookkeeping a bit and the formula has
+    // to be modified to expand like this (N{x} stands for numerator of x,
+    // D{x} for denominator of x):
+    //     N{m[k+1](r,c)} = N{m[k](k,k)}*N{m[k](r,c)}*D{m[k](r,k)}*D{m[k](k,c)}
+    //                     -N{m[k](r,k)}*N{m[k](k,c)}*D{m[k](k,k)}*D{m[k](r,c)}
+    //     D{m[k+1](r,c)} = D{m[k](k,k)}*D{m[k](r,c)}*D{m[k](r,k)}*D{m[k](k,c)}
+    // where for k>1 we now divide N{m[k+1](r,c)} by
+    //     N{m[k-1](k-1,k-1)}
+    // and D{m[k+1](r,c)} by
+    //     D{m[k-1](k-1,k-1)}.
     
+    GINAC_ASSERT(det || row==col);
     ensure_if_modifiable();
+    if (rows()==1)
+        return 1;
+    
+    int sign = 1;
+    ex divisor_n = 1;
+    ex divisor_d = 1;
+    ex dividend_n;
+    ex dividend_d;
+    
+    // We populate temporary matrices to subsequently operate on.  There is
+    // one holding numerators and another holding denominators of entries.
+    // This is a must since the evaluator (or even earlier mul's constructor)
+    // might cancel some trivial element which causes divide() to fail.  The
+    // elements are normalized first (yes, even though this algorithm doesn't
+    // need GCDs) since the elements of *this might be unnormalized, which
+    // makes things more complicated than they need to be.
+    matrix tmp_n(*this);
+    matrix tmp_d(row,col);  // for denominators, if needed
+    lst srl;  // symbol replacement list
+    exvector::iterator it = m.begin();
+    exvector::iterator tmp_n_it = tmp_n.m.begin();
+    exvector::iterator tmp_d_it = tmp_d.m.begin();
+    for (; it!= m.end(); ++it, ++tmp_n_it, ++tmp_d_it) {
+        (*tmp_n_it) = (*it).normal().to_rational(srl);
+        (*tmp_d_it) = (*tmp_n_it).denom();
+        (*tmp_n_it) = (*tmp_n_it).numer();
+    }
+    
     for (unsigned r1=0; r1<row-1; ++r1) {
-        int indx = pivot(r1);
-        if (indx==-1)
-            return 0;  // Note: leaves *this in a messy state.
-        if (indx>0)
+//         cout << "==<" << r1 << ">" << string(60,'=') << endl;
+        int indx = tmp_n.pivot(r1);
+        if (det && indx==-1)
+            return 0;  // FIXME: what to do if det is false?
+        if (indx>0) {
             sign = -sign;
-        if (r1>0)
-            divisor = this->m[(r1-1)*col + (r1-1)];
+            // rows r1 and indx were swapped, so pivot matrix tmp_d:
+            for (unsigned c=0; c<col; ++c)
+                tmp_d.m[row*indx+c].swap(tmp_d.m[row*r1+c]);
+        }
+//         cout << tmp_n << endl;
+//         cout << tmp_d << endl;
+        if (r1>0) {
+            divisor_n = tmp_n.m[(r1-1)*col+(r1-1)].expand();
+            divisor_d = tmp_d.m[(r1-1)*col+(r1-1)].expand();
+            // save space by deleting no longer needed elements:
+            if (det) {
+                for (unsigned c=0; c<col; ++c) {
+                    tmp_n.m[(r1-1)*col+c] = 0;
+                    tmp_d.m[(r1-1)*col+c] = 1;
+                }
+            }
+        }
         for (unsigned r2=r1+1; r2<row; ++r2) {
-            for (unsigned c=r1+1; c<col; ++c)
-                this->m[r2*col+c] = ((this->m[r1*col+r1]*this->m[r2*col+c] - this->m[r2*col+r1]*this->m[r1*col+c])/divisor).normal();
+            for (unsigned c=r1+1; c<col; ++c) {
+                dividend_n = (tmp_n.m[r1*col+r1]*tmp_n.m[r2*col+c]*
+                              tmp_d.m[r2*col+r1]*tmp_d.m[r1*col+c]
+                             -tmp_n.m[r2*col+r1]*tmp_n.m[r1*col+c]*
+                              tmp_d.m[r1*col+r1]*tmp_d.m[r2*col+c]).expand();
+                dividend_d = (tmp_d.m[r2*col+r1]*tmp_d.m[r1*col+c]*
+                              tmp_d.m[r1*col+r1]*tmp_d.m[r2*col+c]).expand();
+//                 cout << "Element " << r2 << ',' << c << endl;
+//                 cout << "dividend_n==" << dividend_n << endl;
+//                 cout << "dividend_d==" << dividend_d << endl;
+//                 cout << " divisor_n==" << divisor_n << endl;
+//                 cout << " divisor_d==" << divisor_d << endl;
+//                 cout << string(20,'-') << endl;
+                bool check = divide(dividend_n, divisor_n,
+                                    tmp_n.m[r2*col+c],true);
+                check &= divide(dividend_d, divisor_d,
+                                tmp_d.m[r2*col+c],true);
+                GINAC_ASSERT(check);
+            }
+            // fill up left hand side.
             for (unsigned c=0; c<=r1; ++c)
-                this->m[r2*col+c] = _ex0();
+                tmp_n.m[r2*col+c] = _ex0();
         }
+//         cout << tmp_n << endl;
+//         cout << tmp_d << endl;        
     }
+    // repopulate *this matrix:
+    it = m.begin();
+    tmp_n_it = tmp_n.m.begin();
+    tmp_d_it = tmp_d.m.begin();
+    for (; it!= m.end(); ++it, ++tmp_n_it, ++tmp_d_it)
+        (*it) = ((*tmp_n_it)/(*tmp_d_it)).subs(srl);
     
     return sign;
 }