[SciPy-dev] 12 errors using 0.7.3.1538 0.4.2_1461

Stephen Walton stephen.walton at csun.edu
Wed Nov 30 16:37:42 EST 2005


I'm afraid that I'm getting a very similar set of errors to Nils.  I 
have BLAS, LAPACK, and ATLAS 3.7.11 locally compiled using Absoft 
Fortran 95, and Scipy also compiled with the same compiler, on Fedora 
Core 4.  On another FC4 system, which is using gfortran 4.0.2 as the 
compiler and ATLAS 3.6.0 distributed by Fedora Extras, I'm getting the 
same 12 errors as Nils.  Output from the Absoft based system below.  
Both are scipy core version 0.7.4.1545 and scipy version 0.4.2_1443

======================================================================
ERROR: check_random (scipy.linalg.decomp.test_decomp.test_cholesky)
----------------------------------------------------------------------
Traceback (most recent call last):
  File 
"/usr/lib/python2.4/site-packages/scipy/linalg/tests/test_decomp.py", 
line 283, in check_random
    c = cholesky(a)
  File "/usr/lib/python2.4/site-packages/scipy/linalg/decomp.py", line 
334, in cholesky
    if info>0: raise LinAlgError, "matrix not positive definite"
LinAlgError: matrix not positive definite

======================================================================
ERROR: Check whether adding a dense matrix to a sparse matrix works
----------------------------------------------------------------------
Traceback (most recent call last):
  File 
"/usr/lib/python2.4/site-packages/scipy/sparse/tests/test_sparse.py", 
line 148, in check_add_dense
    sum1 = self.dat + self.datsp
  File "/usr/lib/python2.4/site-packages/scipy/sparse/sparse.py", line 
502, in __radd__
    raise NotImplementedError, 'adding a scalar to a CSC matrix is ' \
NotImplementedError: adding a scalar to a CSC matrix is not yet supported

======================================================================
ERROR: check_matmat (scipy.sparse.sparse.test_sparse.test_csc)
----------------------------------------------------------------------
Traceback (most recent call last):
  File 
"/usr/lib/python2.4/site-packages/scipy/sparse/tests/test_sparse.py", 
line 84, in check_matmat
    assert_array_almost_equal((a*bsp).todense(), dot(a,b))
AttributeError: 'scipy.ndarray' object has no attribute 'todense'

======================================================================
ERROR: Check whether adding a dense matrix to a sparse matrix works
----------------------------------------------------------------------
Traceback (most recent call last):
  File 
"/usr/lib/python2.4/site-packages/scipy/sparse/tests/test_sparse.py", 
line 148, in check_add_dense
    sum1 = self.dat + self.datsp
  File "/usr/lib/python2.4/site-packages/scipy/sparse/sparse.py", line 
173, in __radd__
    return csc.__radd__(other)
  File "/usr/lib/python2.4/site-packages/scipy/sparse/sparse.py", line 
502, in __radd__
    raise NotImplementedError, 'adding a scalar to a CSC matrix is ' \
NotImplementedError: adding a scalar to a CSC matrix is not yet supported

======================================================================
ERROR: check_matmat (scipy.sparse.sparse.test_sparse.test_csr)
----------------------------------------------------------------------
Traceback (most recent call last):
  File 
"/usr/lib/python2.4/site-packages/scipy/sparse/tests/test_sparse.py", 
line 84, in check_matmat
    assert_array_almost_equal((a*bsp).todense(), dot(a,b))
AttributeError: 'scipy.ndarray' object has no attribute 'todense'

======================================================================
ERROR: Check whether adding a dense matrix to a sparse matrix works
----------------------------------------------------------------------
Traceback (most recent call last):
  File 
"/usr/lib/python2.4/site-packages/scipy/sparse/tests/test_sparse.py", 
line 149, in check_add_dense
    assert_array_equal(sum1, 2*self.dat)
  File "/usr/lib/python2.4/site-packages/scipy/test/testing.py", line 
724, in assert_array_equal
    reduced = ravel(equal(x,y))
  File "/usr/lib/python2.4/site-packages/scipy/sparse/sparse.py", line 
146, in __cmp__
    raise TypeError, "comparison of sparse matrices not implemented"
TypeError: comparison of sparse matrices not implemented

======================================================================
ERROR: check_matmat (scipy.sparse.sparse.test_sparse.test_dok)
----------------------------------------------------------------------
Traceback (most recent call last):
  File 
"/usr/lib/python2.4/site-packages/scipy/sparse/tests/test_sparse.py", 
line 84, in check_matmat
    assert_array_almost_equal((a*bsp).todense(), dot(a,b))
AttributeError: 'scipy.ndarray' object has no attribute 'todense'

======================================================================
ERROR: line-search Newton conjugate gradient optimization routine
----------------------------------------------------------------------
Traceback (most recent call last):
  File 
"/usr/lib/python2.4/site-packages/scipy/optimize/tests/test_optimize.py", 
line 103, in check_ncg
    full_output=False, disp=False, retall=False)
  File "/usr/lib/python2.4/site-packages/scipy/optimize/optimize.py", 
line 969, in fmin_ncg
    alphak, fc, gc, old_fval = line_search_BFGS(f,xk,pk,gfk,old_fval)
  File "/usr/lib/python2.4/site-packages/scipy/optimize/optimize.py", 
line 556, in line_search_BFGS
    phi_a2 = apply(f,(xk+alpha2*pk,)+args)
  File "/usr/lib/python2.4/site-packages/scipy/optimize/optimize.py", 
line 133, in function_wrapper
    return function(x, *args)
  File 
"/usr/lib/python2.4/site-packages/scipy/optimize/tests/test_optimize.py", 
line 30, in func
    raise RuntimeError, "too many iterations in optimization routine"
RuntimeError: too many iterations in optimization routine

======================================================================
ERROR: Check whether adding a dense matrix to a sparse matrix works
----------------------------------------------------------------------
Traceback (most recent call last):
  File 
"/usr/lib/python2.4/site-packages/scipy/sparse/tests/test_sparse.py", 
line 148, in check_add_dense
    sum1 = self.dat + self.datsp
  File "/usr/lib/python2.4/site-packages/scipy/sparse/sparse.py", line 
502, in __radd__
    raise NotImplementedError, 'adding a scalar to a CSC matrix is ' \
NotImplementedError: adding a scalar to a CSC matrix is not yet supported

======================================================================
ERROR: check_matmat (scipy.sparse.test_sparse.test_csc)
----------------------------------------------------------------------
Traceback (most recent call last):
  File 
"/usr/lib/python2.4/site-packages/scipy/sparse/tests/test_sparse.py", 
line 84, in check_matmat
    assert_array_almost_equal((a*bsp).todense(), dot(a,b))
AttributeError: 'scipy.ndarray' object has no attribute 'todense'

======================================================================
ERROR: Check whether adding a dense matrix to a sparse matrix works
----------------------------------------------------------------------
Traceback (most recent call last):
  File 
"/usr/lib/python2.4/site-packages/scipy/sparse/tests/test_sparse.py", 
line 148, in check_add_dense
    sum1 = self.dat + self.datsp
  File "/usr/lib/python2.4/site-packages/scipy/sparse/sparse.py", line 
173, in __radd__
    return csc.__radd__(other)
  File "/usr/lib/python2.4/site-packages/scipy/sparse/sparse.py", line 
502, in __radd__
    raise NotImplementedError, 'adding a scalar to a CSC matrix is ' \
NotImplementedError: adding a scalar to a CSC matrix is not yet supported

======================================================================
ERROR: check_matmat (scipy.sparse.test_sparse.test_csr)
----------------------------------------------------------------------
Traceback (most recent call last):
  File 
"/usr/lib/python2.4/site-packages/scipy/sparse/tests/test_sparse.py", 
line 84, in check_matmat
    assert_array_almost_equal((a*bsp).todense(), dot(a,b))
AttributeError: 'scipy.ndarray' object has no attribute 'todense'

======================================================================
ERROR: Check whether adding a dense matrix to a sparse matrix works
----------------------------------------------------------------------
Traceback (most recent call last):
  File 
"/usr/lib/python2.4/site-packages/scipy/sparse/tests/test_sparse.py", 
line 149, in check_add_dense
    assert_array_equal(sum1, 2*self.dat)
  File "/usr/lib/python2.4/site-packages/scipy/test/testing.py", line 
724, in assert_array_equal
    reduced = ravel(equal(x,y))
  File "/usr/lib/python2.4/site-packages/scipy/sparse/sparse.py", line 
146, in __cmp__
    raise TypeError, "comparison of sparse matrices not implemented"
TypeError: comparison of sparse matrices not implemented

======================================================================
ERROR: check_matmat (scipy.sparse.test_sparse.test_dok)
----------------------------------------------------------------------
Traceback (most recent call last):
  File 
"/usr/lib/python2.4/site-packages/scipy/sparse/tests/test_sparse.py", 
line 84, in check_matmat
    assert_array_almost_equal((a*bsp).todense(), dot(a,b))
AttributeError: 'scipy.ndarray' object has no attribute 'todense'

======================================================================
FAIL: check_double_integral 
(scipy.integrate.quadpack.test_quadpack.test_quad)
----------------------------------------------------------------------
Traceback (most recent call last):
  File 
"/usr/lib/python2.4/site-packages/scipy/integrate/tests/test_quadpack.py", 
line 95, in check_double_integral
    5/6.0 * (b**3.0-a**3.0))
  File 
"/usr/lib/python2.4/site-packages/scipy/integrate/tests/test_quadpack.py", 
line 11, in assert_quad
    assert err < errTol, (err, errTol)
AssertionError: (23403637477.367432, 1.4999999999999999e-08)

======================================================================
FAIL: check_triple_integral 
(scipy.integrate.quadpack.test_quadpack.test_quad)
----------------------------------------------------------------------
Traceback (most recent call last):
  File 
"/usr/lib/python2.4/site-packages/scipy/integrate/tests/test_quadpack.py", 
line 106, in check_triple_integral
    8/3.0 * (b**4.0 - a**4.0))
  File 
"/usr/lib/python2.4/site-packages/scipy/integrate/tests/test_quadpack.py", 
line 9, in assert_quad
    assert abs(value-tabledValue) < err, (value, tabledValue, err)
AssertionError: (4.2487097720268533e-21, 40.0, 1.5870895476678149e-21)

======================================================================
FAIL: check_expon (scipy.stats.morestats.test_morestats.test_anderson)
----------------------------------------------------------------------
Traceback (most recent call last):
  File 
"/usr/lib/python2.4/site-packages/scipy/stats/tests/test_morestats.py", 
line 57, in check_expon
    assert_array_less(A, crit[-2:])
  File "/usr/lib/python2.4/site-packages/scipy/test/testing.py", line 
782, in assert_array_less
    assert cond,\
AssertionError:
Arrays are not less-ordered (mismatch 50.0%):
        Array 1: 1.603235478998613
        Array 2: [ 1.587               1.9339999999999999]


======================================================================
FAIL: check_sygv (scipy.lib.lapack.test_lapack.test_flapack_float)
----------------------------------------------------------------------
Traceback (most recent call last):
  File 
"/usr/lib/python2.4/site-packages/scipy/lib/lapack/tests/gesv_tests.py", 
line 15, in check_sygv
    assert_array_almost_equal(dot(a,v[:,i]),w[i]*dot(b,v[:,i]),self.decimal)
  File "/usr/lib/python2.4/site-packages/scipy/test/testing.py", line 
758, in assert_array_almost_equal
    assert cond,\
AssertionError:
Arrays are not almost equal (mismatch 100.0%):
        Array 1: [      nan       nan       nan]
        Array 2: [      nan       nan       nan]


----------------------------------------------------------------------
Ran 1223 tests in 13.048s

FAILED (failures=4, errors=14)




More information about the SciPy-Dev mailing list