[SciPy-user] SciPy op Opteron install

Giovanni Samaey giovanni.samaey at cs.kuleuven.ac.be
Fri Oct 28 08:34:23 EDT 2005


Hi all,

I am proud to say that I finally managed to do a complete install of svn 
scipy on our new cluster.
I will briefly report on the install process, which is kind of tricky.  
I also have some remaining questions.

The setup is the following:  blas and lapack come with the AMD Core Math 
Library, which was installed on the system.
Everything is 64bit.
The preferred compiler is pathscale, but also gcc is available (3.4.4 
and 3.4.0 -- I used 3.4.4 ).
(All other pythonrelated stuff has been compiled with pathscale.)

Building newcore works without any problems; newscipy is a bit messier, 
since I get an "Internal compiler error during WHIRL"
(Nested functions not implemented...) on

pathcc -fno-strict-aliasing -DNDEBUG -g -O3 -Wall -Wstrict-prototypes 
-fPIC -Ibuild/src 
-I/data/home/u0038151/lib/python2.4/site-packages/scipy/base/include 
-I/apps/prod/python/2.4.1/include/python2.4 -c 
build/src/Lib/interpolate/dfitpackmodule.c -o 
build/temp.linux-x86_64-2.4/build/src/Lib/interpolate/dfitpackmodule.o

I replaced pathcc by gcc; this succeeded and I continued the build.
Then I got 8 fortran errors on the command

pathf90 -Wall -fno-second-underscore -fPIC -O2 -funroll-loops 
-Ibuild/src 
-I/data/home/u0038151/lib/python2.4/site-packages/scipy/base/include 
-I/apps/prod/python/2.4.1/include/python2.4 -c -c 
build/src/Lib/sparse/sparsetools/spblas.f -o 
build/temp.linux-x86_64-2.4/build/src/Lib/sparse/sparsetools/spblas.o

I got past this by replacing pathf90 by g77.  Then the build succeeded.  
I don't know how "legal" this is :-)

Importing scipy gives the already reported

 >>> import scipy
Importing io to scipy
Importing interpolate to scipy
Importing fftpack to scipy
Importing special to scipy
Importing cluster to scipy
Importing sparse to scipy
Importing signal to scipy
Failed to import signal
cannot import name comb
Importing utils to scipy
Importing integrate to scipy
Importing optimize to scipy
Importing linalg to scipy
Importing stats to scipy

And running scipy.test() returns 38 failures/4 errors.  (They are listed 
at the bottom of the message.)
Please let me know whether these problems are due to my setup (the 64 
bit Opteron), which are unsolved for now,
due to some mistakes in installing, which I should solve, or due to my 
"special bypass".

======================================================================
ERROR: check_integer 
(scipy.io.array_import.test_array_import.test_read_array)
----------------------------------------------------------------------
Traceback (most recent call last):
  File 
"/data/home/u0038151/lib/python2.4/site-packages/scipy/io/tests/test_array_import.py", 
line 62, in check_integer
    b = io.read_array(fname,atype=N.Int)
  File 
"/data/home/u0038151/lib/python2.4/site-packages/scipy/io/array_import.py", 
line 359, in read_array
    raise ValueError, "One of the array types is invalid, k=%d" % k
ValueError: One of the array types is invalid, k=0

======================================================================
ERROR: check_singleton (scipy.base.getlimits.test_getlimits.test_longdouble)
----------------------------------------------------------------------
Traceback (most recent call last):
  File 
"/data/home/u0038151/lib/python2.4/site-packages/scipy/base/tests/test_getlimits.py", 
line 39, in check_singleton
    ftype = finfo(longdouble)
  File 
"/data/home/u0038151/lib/python2.4/site-packages/scipy/base/getlimits.py", 
line 49, in __new__
    obj = object.__new__(cls)._init(dtype)
  File 
"/data/home/u0038151/lib/python2.4/site-packages/scipy/base/getlimits.py", 
line 75, in _init
    "scipy longfloat precision floating "\
  File 
"/data/home/u0038151/lib/python2.4/site-packages/scipy/base/machar.py", 
line 226, in __init__
    self._str_epsneg = float_to_str(epsneg)
  File 
"/data/home/u0038151/lib/python2.4/site-packages/scipy/base/getlimits.py", 
line 74, in <lambda>
    lambda v:str(array(_frz(v)[0],'g')),
  File 
"/data/home/u0038151/lib/python2.4/site-packages/scipy/base/numeric.py", 
line 204, in array_str
    return array2string(a, max_line_width, precision, suppress_small, ' 
', "")
  File 
"/data/home/u0038151/lib/python2.4/site-packages/scipy/base/arrayprint.py", 
line 189, in array2string
    x = a[()]
ValueError: 0-d arrays can't be indexed.

======================================================================
ERROR: check_assoc_laguerre 
(scipy.special.basic.test_basic.test_assoc_laguerre)
----------------------------------------------------------------------
Traceback (most recent call last):
  File 
"/data/home/u0038151/lib/python2.4/site-packages/scipy/special/tests/test_basic.py", 
line 529, in check_assoc_laguerre
    assert_array_almost_equal(a2,a1(.2),8)
  File 
"/data/home/u0038151/lib/python2.4/site-packages/scipy/test/testing.py", 
line 732, in assert_array_almost_equal
    print x, y
  File 
"/data/home/u0038151/lib/python2.4/site-packages/scipy/base/numeric.py", 
line 204, in array_str
    return array2string(a, max_line_width, precision, suppress_small, ' 
', "")
  File 
"/data/home/u0038151/lib/python2.4/site-packages/scipy/base/arrayprint.py", 
line 189, in array2string
    x = a[()]
ValueError: 0-d arrays can't be indexed.

======================================================================
ERROR: check_y0_zeros (scipy.special.basic.test_basic.test_y0_zeros)
----------------------------------------------------------------------
Traceback (most recent call last):
  File 
"/data/home/u0038151/lib/python2.4/site-packages/scipy/special/tests/test_basic.py", 
line 2033, in check_y0_zeros
    assert_array_almost_equal(abs(yv(1,all)-allval),0.0,11)
  File 
"/data/home/u0038151/lib/python2.4/site-packages/scipy/test/testing.py", 
line 732, in assert_array_almost_equal
    print x, y
  File 
"/data/home/u0038151/lib/python2.4/site-packages/scipy/base/numeric.py", 
line 204, in array_str
    return array2string(a, max_line_width, precision, suppress_small, ' 
', "")
  File 
"/data/home/u0038151/lib/python2.4/site-packages/scipy/base/arrayprint.py", 
line 189, in array2string
    x = a[()]
ValueError: 0-d arrays can't be indexed.

======================================================================
FAIL: check_matvec (scipy.sparse.sparse.test_sparse.test_csc)
----------------------------------------------------------------------
Traceback (most recent call last):
  File 
"/data/home/u0038151/lib/python2.4/site-packages/scipy/sparse/tests/test_sparse.py", 
line 66, in check_matvec
    assert_array_almost_equal([1,2,3,4]*b,dot([1,2,3,4],b.todense()))
  File 
"/data/home/u0038151/lib/python2.4/site-packages/scipy/test/testing.py", 
line 727, in assert_array_almost_equal
    assert cond,\
AssertionError:
Arrays are not almost equal (mismatch 100.0%):
        Array 1: [ 0.  0.  0.]
        Array 2: [ 17.  14.   9.]


======================================================================
FAIL: check_matvec (scipy.sparse.sparse.test_sparse.test_csr)
----------------------------------------------------------------------
Traceback (most recent call last):
  File 
"/data/home/u0038151/lib/python2.4/site-packages/scipy/sparse/tests/test_sparse.py", 
line 66, in check_matvec
    assert_array_almost_equal([1,2,3,4]*b,dot([1,2,3,4],b.todense()))
  File 
"/data/home/u0038151/lib/python2.4/site-packages/scipy/test/testing.py", 
line 727, in assert_array_almost_equal
    assert cond,\
AssertionError:
Arrays are not almost equal (mismatch 100.0%):
        Array 1: [ 0.  0.  0.]
        Array 2: [ 17.  14.   9.]


======================================================================
FAIL: check_matvec (scipy.sparse.sparse.test_sparse.test_dok)
----------------------------------------------------------------------
Traceback (most recent call last):
  File 
"/data/home/u0038151/lib/python2.4/site-packages/scipy/sparse/tests/test_sparse.py", 
line 66, in check_matvec
    assert_array_almost_equal([1,2,3,4]*b,dot([1,2,3,4],b.todense()))
  File 
"/data/home/u0038151/lib/python2.4/site-packages/scipy/test/testing.py", 
line 727, in assert_array_almost_equal
    assert cond,\
AssertionError:
Arrays are not almost equal (mismatch 100.0%):
        Array 1: [ 0.  0.  0.]
        Array 2: [ 17.  14.   9.]


======================================================================
FAIL: check_simple (scipy.linalg.basic.test_basic.test_det)
----------------------------------------------------------------------
Traceback (most recent call last):
  File 
"/data/home/u0038151/lib/python2.4/site-packages/scipy/linalg/tests/test_basic.py", 
line 273, in check_simple
    assert_almost_equal(a_det,-2.0)
  File 
"/data/home/u0038151/lib/python2.4/site-packages/scipy/test/testing.py", 
line 649, in assert_almost_equal
    assert round(abs(desired - actual),decimal) == 0, msg
AssertionError:
Items are not equal:
DESIRED: -2.0
ACTUAL: nan

======================================================================
FAIL: check_simple_exact (scipy.linalg.basic.test_basic.test_lstsq)
----------------------------------------------------------------------
Traceback (most recent call last):
  File 
"/data/home/u0038151/lib/python2.4/site-packages/scipy/linalg/tests/test_basic.py", 
line 356, in check_simple_exact
    assert_array_almost_equal(Numeric.matrixmultiply(a,x),b)
  File 
"/data/home/u0038151/lib/python2.4/site-packages/scipy/test/testing.py", 
line 727, in assert_array_almost_equal
    assert cond,\
AssertionError:
Arrays are not almost equal (mismatch 50.0%):
        Array 1: [0 0]
        Array 2: [1 0]


======================================================================
FAIL: check_simple_overdet (scipy.linalg.basic.test_basic.test_lstsq)
----------------------------------------------------------------------
Traceback (most recent call last):
  File 
"/data/home/u0038151/lib/python2.4/site-packages/scipy/linalg/tests/test_basic.py", 
line 363, in check_simple_overdet
    assert_array_almost_equal(x,direct_lstsq(a,b))
  File 
"/data/home/u0038151/lib/python2.4/site-packages/scipy/test/testing.py", 
line 727, in assert_array_almost_equal
    assert cond,\
AssertionError:
Arrays are not almost equal (mismatch 100.0%):
        Array 1: [-9223372036854775808                    0]
        Array 2: [-0.4285714  0.8571429]


======================================================================
FAIL: check_simple (scipy.linalg.basic.test_basic.test_solve)
----------------------------------------------------------------------
Traceback (most recent call last):
  File 
"/data/home/u0038151/lib/python2.4/site-packages/scipy/linalg/tests/test_basic.py", 
line 74, in check_simple
    assert_array_almost_equal(Numeric.matrixmultiply(a,x),b)
  File 
"/data/home/u0038151/lib/python2.4/site-packages/scipy/test/testing.py", 
line 727, in assert_array_almost_equal
    assert cond,\
AssertionError:
Arrays are not almost equal (mismatch 50.0%):
        Array 1: [-9223372036854775808                    0]
        Array 2: [1 0]


======================================================================
FAIL: check_simple_sym (scipy.linalg.basic.test_basic.test_solve)
----------------------------------------------------------------------
Traceback (most recent call last):
  File 
"/data/home/u0038151/lib/python2.4/site-packages/scipy/linalg/tests/test_basic.py", 
line 81, in check_simple_sym
    assert_array_almost_equal(Numeric.matrixmultiply(a,x),b)
  File 
"/data/home/u0038151/lib/python2.4/site-packages/scipy/test/testing.py", 
line 727, in assert_array_almost_equal
    assert cond,\
AssertionError:
Arrays are not almost equal (mismatch 50.0%):
        Array 1: [0 0]
        Array 2: [1 0]


======================================================================
FAIL: check_chebyc (scipy.special.basic.test_basic.test_chebyc)
----------------------------------------------------------------------
Traceback (most recent call last):
  File 
"/data/home/u0038151/lib/python2.4/site-packages/scipy/special/tests/test_basic.py", 
line 679, in check_chebyc
    assert_array_almost_equal(C2.c,[1,0,-2],13)
  File 
"/data/home/u0038151/lib/python2.4/site-packages/scipy/test/testing.py", 
line 717, in assert_array_almost_equal
    assert cond, msg + '\n\t' + err_msg
AssertionError:
Arrays are not almost equal (shapes mismatch):
        Shape of array 1: (5,)
        Shape of array 2: (3,)


======================================================================
FAIL: check_chebys (scipy.special.basic.test_basic.test_chebys)
----------------------------------------------------------------------
Traceback (most recent call last):
  File 
"/data/home/u0038151/lib/python2.4/site-packages/scipy/special/tests/test_basic.py", 
line 695, in check_chebys
    assert_array_almost_equal(S2.c,[1,0,-1],13)
  File 
"/data/home/u0038151/lib/python2.4/site-packages/scipy/test/testing.py", 
line 717, in assert_array_almost_equal
    assert cond, msg + '\n\t' + err_msg
AssertionError:
Arrays are not almost equal (shapes mismatch):
        Shape of array 1: (5,)
        Shape of array 2: (3,)


======================================================================
FAIL: check_chebyt (scipy.special.basic.test_basic.test_chebyt)
----------------------------------------------------------------------
Traceback (most recent call last):
  File 
"/data/home/u0038151/lib/python2.4/site-packages/scipy/special/tests/test_basic.py", 
line 711, in check_chebyt
    assert_array_almost_equal(T2.c,[2,0,-1],13)
  File 
"/data/home/u0038151/lib/python2.4/site-packages/scipy/test/testing.py", 
line 717, in assert_array_almost_equal
    assert cond, msg + '\n\t' + err_msg
AssertionError:
Arrays are not almost equal (shapes mismatch):
        Shape of array 1: (5,)
        Shape of array 2: (3,)


======================================================================
FAIL: check_chebyu (scipy.special.basic.test_basic.test_chebyu)
----------------------------------------------------------------------
Traceback (most recent call last):
  File 
"/data/home/u0038151/lib/python2.4/site-packages/scipy/special/tests/test_basic.py", 
line 727, in check_chebyu
    assert_array_almost_equal(U2.c,[4,0,-1],13)
  File 
"/data/home/u0038151/lib/python2.4/site-packages/scipy/test/testing.py", 
line 717, in assert_array_almost_equal
    assert cond, msg + '\n\t' + err_msg
AssertionError:
Arrays are not almost equal (shapes mismatch):
        Shape of array 1: (5,)
        Shape of array 2: (3,)


======================================================================
FAIL: check_gegenbauer (scipy.special.basic.test_basic.test_gegenbauer)
----------------------------------------------------------------------
Traceback (most recent call last):
  File 
"/data/home/u0038151/lib/python2.4/site-packages/scipy/special/tests/test_basic.py", 
line 1092, in check_gegenbauer
    assert_array_almost_equal(Ca2.c,array([2*a*(a+1),0,-a]),13)
  File 
"/data/home/u0038151/lib/python2.4/site-packages/scipy/test/testing.py", 
line 717, in assert_array_almost_equal
    assert cond, msg + '\n\t' + err_msg
AssertionError:
Arrays are not almost equal (shapes mismatch):
        Shape of array 1: (5,)
        Shape of array 2: (3,)


======================================================================
FAIL: check_h1vp (scipy.special.basic.test_basic.test_h1vp)
----------------------------------------------------------------------
Traceback (most recent call last):
  File 
"/data/home/u0038151/lib/python2.4/site-packages/scipy/special/tests/test_basic.py", 
line 1107, in check_h1vp
    assert_almost_equal(h1,h1real,8)
  File 
"/data/home/u0038151/lib/python2.4/site-packages/scipy/test/testing.py", 
line 649, in assert_almost_equal
    assert round(abs(desired - actual),decimal) == 0, msg
AssertionError:
Items are not equal:
DESIRED: (0.49812630170362004+63.055272295669909j)
ACTUAL: 0j

======================================================================
FAIL: check_h2vp (scipy.special.basic.test_basic.test_h2vp)
----------------------------------------------------------------------
Traceback (most recent call last):
  File 
"/data/home/u0038151/lib/python2.4/site-packages/scipy/special/tests/test_basic.py", 
line 1114, in check_h2vp
    assert_almost_equal(h2,h2real,8)
  File 
"/data/home/u0038151/lib/python2.4/site-packages/scipy/test/testing.py", 
line 649, in assert_almost_equal
    assert round(abs(desired - actual),decimal) == 0, msg
AssertionError:
Items are not equal:
DESIRED: (0.49812630170362004-63.055272295669909j)
ACTUAL: 0j

======================================================================
FAIL: check_hankel1 (scipy.special.basic.test_basic.test_hankel1)
----------------------------------------------------------------------
Traceback (most recent call last):
  File 
"/data/home/u0038151/lib/python2.4/site-packages/scipy/special/tests/test_basic.py", 
line 1013, in check_hankel1
    assert_almost_equal(hank1,hankrl,8)
  File 
"/data/home/u0038151/lib/python2.4/site-packages/scipy/test/testing.py", 
line 649, in assert_almost_equal
    assert round(abs(desired - actual),decimal) == 0, msg
AssertionError:
Items are not equal:
DESIRED: (0.049937526036241998-6.4589510947020274j)
ACTUAL: (2.3177863641675947e-310+2.3296109222859581e-317j)

======================================================================
FAIL: check_hankel2 (scipy.special.basic.test_basic.test_hankel2)
----------------------------------------------------------------------
Traceback (most recent call last):
  File 
"/data/home/u0038151/lib/python2.4/site-packages/scipy/special/tests/test_basic.py", 
line 1027, in check_hankel2
    assert_almost_equal(hank2,hankrl2,8)
  File 
"/data/home/u0038151/lib/python2.4/site-packages/scipy/test/testing.py", 
line 649, in assert_almost_equal
    assert round(abs(desired - actual),decimal) == 0, msg
AssertionError:
Items are not equal:
DESIRED: (0.049937526036241998+6.4589510947020274j)
ACTUAL: (2.3177863641675947e-310+2.3296109222859581e-317j)

======================================================================
FAIL: check_hermite (scipy.special.basic.test_basic.test_hermite)
----------------------------------------------------------------------
Traceback (most recent call last):
  File 
"/data/home/u0038151/lib/python2.4/site-packages/scipy/special/tests/test_basic.py", 
line 1047, in check_hermite
    assert_array_almost_equal(H2.c,[4,0,-2],13)
  File 
"/data/home/u0038151/lib/python2.4/site-packages/scipy/test/testing.py", 
line 717, in assert_array_almost_equal
    assert cond, msg + '\n\t' + err_msg
AssertionError:
Arrays are not almost equal (shapes mismatch):
        Shape of array 1: (5,)
        Shape of array 2: (3,)


======================================================================
FAIL: check_hermitenorm (scipy.special.basic.test_basic.test_hermite)
----------------------------------------------------------------------
Traceback (most recent call last):
  File 
"/data/home/u0038151/lib/python2.4/site-packages/scipy/special/tests/test_basic.py", 
line 1069, in check_hermitenorm
    assert_array_almost_equal(H1.c,he1.c,13)
  File 
"/data/home/u0038151/lib/python2.4/site-packages/scipy/test/testing.py", 
line 727, in assert_array_almost_equal
    assert cond,\
AssertionError:
Arrays are not almost equal (mismatch 50.0%):
        Array 1: [ 1.  0.]
        Array 2: [ 0.35355339059327  0.              ]


======================================================================
FAIL: check_i0e (scipy.special.basic.test_basic.test_i0e)
----------------------------------------------------------------------
Traceback (most recent call last):
  File 
"/data/home/u0038151/lib/python2.4/site-packages/scipy/special/tests/test_basic.py", 
line 1177, in check_i0e
    assert_almost_equal(oize,oizer,8)
  File 
"/data/home/u0038151/lib/python2.4/site-packages/scipy/test/testing.py", 
line 649, in assert_almost_equal
    assert round(abs(desired - actual),decimal) == 0, msg
AssertionError:
Items are not equal:
DESIRED: 0.0
ACTUAL: 0.90710092578230106

======================================================================
FAIL: check_i1e (scipy.special.basic.test_basic.test_i1e)
----------------------------------------------------------------------
Traceback (most recent call last):
  File 
"/data/home/u0038151/lib/python2.4/site-packages/scipy/special/tests/test_basic.py", 
line 1192, in check_i1e
    assert_almost_equal(oi1e,oi1er,8)
  File 
"/data/home/u0038151/lib/python2.4/site-packages/scipy/test/testing.py", 
line 649, in assert_almost_equal
    assert round(abs(desired - actual),decimal) == 0, msg
AssertionError:
Items are not equal:
DESIRED: 3.6755005828442021e-317
ACTUAL: 0.045298446808809324

======================================================================
FAIL: check_ive (scipy.special.basic.test_basic.test_ive)
----------------------------------------------------------------------
Traceback (most recent call last):
  File 
"/data/home/u0038151/lib/python2.4/site-packages/scipy/special/tests/test_basic.py", 
line 1229, in check_ive
    assert_almost_equal(ive1,iv1,10)
  File 
"/data/home/u0038151/lib/python2.4/site-packages/scipy/test/testing.py", 
line 649, in assert_almost_equal
    assert round(abs(desired - actual),decimal) == 0, msg
AssertionError:
Items are not equal:
DESIRED: 0.90710092578230106
ACTUAL: 0.0

======================================================================
FAIL: check_jacobi (scipy.special.basic.test_basic.test_jacobi)
----------------------------------------------------------------------
Traceback (most recent call last):
  File 
"/data/home/u0038151/lib/python2.4/site-packages/scipy/special/tests/test_basic.py", 
line 1263, in check_jacobi
    assert_array_almost_equal(P1.c,array([a+b+2,a-b])/2.0,13)
  File 
"/data/home/u0038151/lib/python2.4/site-packages/scipy/test/testing.py", 
line 717, in assert_array_almost_equal
    assert cond, msg + '\n\t' + err_msg
AssertionError:
Arrays are not almost equal (shapes mismatch):
        Shape of array 1: (3,)
        Shape of array 2: (2,)


======================================================================
FAIL: check_jve (scipy.special.basic.test_basic.test_jve)
----------------------------------------------------------------------
Traceback (most recent call last):
  File 
"/data/home/u0038151/lib/python2.4/site-packages/scipy/special/tests/test_basic.py", 
line 1289, in check_jve
    assert_almost_equal(jvexp,0.099500832639235995,8)
  File 
"/data/home/u0038151/lib/python2.4/site-packages/scipy/test/testing.py", 
line 649, in assert_almost_equal
    assert round(abs(desired - actual),decimal) == 0, msg
AssertionError:
Items are not equal:
DESIRED: 0.099500832639235995
ACTUAL: 3.6755005828442021e-317

======================================================================
FAIL: check_k0 (scipy.special.basic.test_basic.test_k0)
----------------------------------------------------------------------
Traceback (most recent call last):
  File 
"/data/home/u0038151/lib/python2.4/site-packages/scipy/special/tests/test_basic.py", 
line 1367, in check_k0
    assert_almost_equal(ozk,ozkr,8)
  File 
"/data/home/u0038151/lib/python2.4/site-packages/scipy/test/testing.py", 
line 649, in assert_almost_equal
    assert round(abs(desired - actual),decimal) == 0, msg
AssertionError:
Items are not equal:
DESIRED: 3.6755005828442021e-317
ACTUAL: 2.4270690247020164

======================================================================
FAIL: check_k0e (scipy.special.basic.test_basic.test_k0e)
----------------------------------------------------------------------
Traceback (most recent call last):
  File 
"/data/home/u0038151/lib/python2.4/site-packages/scipy/special/tests/test_basic.py", 
line 1374, in check_k0e
    assert_almost_equal(ozke,ozker,8)
  File 
"/data/home/u0038151/lib/python2.4/site-packages/scipy/test/testing.py", 
line 649, in assert_almost_equal
    assert round(abs(desired - actual),decimal) == 0, msg
AssertionError:
Items are not equal:
DESIRED: 3.6755005828442021e-317
ACTUAL: 2.6823261022628944

======================================================================
FAIL: check_k1 (scipy.special.basic.test_basic.test_k1)
----------------------------------------------------------------------
Traceback (most recent call last):
  File 
"/data/home/u0038151/lib/python2.4/site-packages/scipy/special/tests/test_basic.py", 
line 1381, in check_k1
    assert_almost_equal(o1k,o1kr,8)
  File 
"/data/home/u0038151/lib/python2.4/site-packages/scipy/test/testing.py", 
line 649, in assert_almost_equal
    assert round(abs(desired - actual),decimal) == 0, msg
AssertionError:
Items are not equal:
DESIRED: 3.6755005828442021e-317
ACTUAL: 9.853844780870606

======================================================================
FAIL: check_k1e (scipy.special.basic.test_basic.test_k1e)
----------------------------------------------------------------------
Traceback (most recent call last):
  File 
"/data/home/u0038151/lib/python2.4/site-packages/scipy/special/tests/test_basic.py", 
line 1388, in check_k1e
    assert_almost_equal(o1ke,o1ker,8)
  File 
"/data/home/u0038151/lib/python2.4/site-packages/scipy/test/testing.py", 
line 649, in assert_almost_equal
    assert round(abs(desired - actual),decimal) == 0, msg
AssertionError:
Items are not equal:
DESIRED: 3.6755005828442021e-317
ACTUAL: 10.890182683049698

======================================================================
FAIL: check_kv (scipy.special.basic.test_basic.test_kv)
----------------------------------------------------------------------
Traceback (most recent call last):
  File 
"/data/home/u0038151/lib/python2.4/site-packages/scipy/special/tests/test_basic.py", 
line 1524, in check_kv
    assert_almost_equal(kv1,1.7527038555281462,8)
  File 
"/data/home/u0038151/lib/python2.4/site-packages/scipy/test/testing.py", 
line 649, in assert_almost_equal
    assert round(abs(desired - actual),decimal) == 0, msg
AssertionError:
Items are not equal:
DESIRED: 1.7527038555281462
ACTUAL: 3.6755005828442021e-317

======================================================================
FAIL: check_genlaguerre (scipy.special.basic.test_basic.test_laguerre)
----------------------------------------------------------------------
Traceback (most recent call last):
  File 
"/data/home/u0038151/lib/python2.4/site-packages/scipy/special/tests/test_basic.py", 
line 1567, in check_genlaguerre
    assert_equal(lag1.c,[-1,k+1])
  File 
"/data/home/u0038151/lib/python2.4/site-packages/scipy/test/testing.py", 
line 619, in assert_equal
    return assert_array_equal(actual, desired, err_msg)
  File 
"/data/home/u0038151/lib/python2.4/site-packages/scipy/test/testing.py", 
line 688, in assert_array_equal
    assert 0 in [len(shape(x)),len(shape(y))] \
AssertionError:
Arrays are not equal (shapes (3,), (2,) mismatch):


======================================================================
FAIL: check_laguerre (scipy.special.basic.test_basic.test_laguerre)
----------------------------------------------------------------------
Traceback (most recent call last):
  File 
"/data/home/u0038151/lib/python2.4/site-packages/scipy/special/tests/test_basic.py", 
line 1554, in check_laguerre
    assert_array_almost_equal(lag1.c,[-1,1],13)
  File 
"/data/home/u0038151/lib/python2.4/site-packages/scipy/test/testing.py", 
line 717, in assert_array_almost_equal
    assert cond, msg + '\n\t' + err_msg
AssertionError:
Arrays are not almost equal (shapes mismatch):
        Shape of array 1: (3,)
        Shape of array 2: (2,)


======================================================================
FAIL: check_legendre (scipy.special.basic.test_basic.test_legendre)
----------------------------------------------------------------------
Traceback (most recent call last):
  File 
"/data/home/u0038151/lib/python2.4/site-packages/scipy/special/tests/test_basic.py", 
line 1584, in check_legendre
    assert_equal(leg2.c,array([3,0,-1])/2.0)
  File 
"/data/home/u0038151/lib/python2.4/site-packages/scipy/test/testing.py", 
line 619, in assert_equal
    return assert_array_equal(actual, desired, err_msg)
  File 
"/data/home/u0038151/lib/python2.4/site-packages/scipy/test/testing.py", 
line 688, in assert_array_equal
    assert 0 in [len(shape(x)),len(shape(y))] \
AssertionError:
Arrays are not equal (shapes (5,), (3,) mismatch):


======================================================================
FAIL: check_round (scipy.special.basic.test_basic.test_round)
----------------------------------------------------------------------
Traceback (most recent call last):
  File 
"/data/home/u0038151/lib/python2.4/site-packages/scipy/special/tests/test_basic.py", 
line 1793, in check_round
    assert_array_equal(rnd,rndrl)
  File 
"/data/home/u0038151/lib/python2.4/site-packages/scipy/test/testing.py", 
line 702, in assert_array_equal
    assert cond,\
AssertionError:
Arrays are not equal (mismatch 25.0%):
        Array 1: [10 10 11 11]
        Array 2: [10 10 10 11]


======================================================================
FAIL: check_yve (scipy.special.basic.test_basic.test_yve)
----------------------------------------------------------------------
Traceback (most recent call last):
  File 
"/data/home/u0038151/lib/python2.4/site-packages/scipy/special/tests/test_basic.py", 
line 2076, in check_yve
    assert_almost_equal(yve2,-3.3238249881118471,8)
  File 
"/data/home/u0038151/lib/python2.4/site-packages/scipy/test/testing.py", 
line 649, in assert_almost_equal
    assert round(abs(desired - actual),decimal) == 0, msg
AssertionError:
Items are not equal:
DESIRED: -3.3238249881118471
ACTUAL: 3.6755005828442021e-317

======================================================================
FAIL: check_data (scipy.stats.morestats.test_morestats.test_binom_test)
----------------------------------------------------------------------
Traceback (most recent call last):
  File 
"/data/home/u0038151/lib/python2.4/site-packages/scipy/stats/tests/test_morestats.py", 
line 104, in check_data
    assert_almost_equal(pval,0.0018833009350757682,11)
  File 
"/data/home/u0038151/lib/python2.4/site-packages/scipy/test/testing.py", 
line 649, in assert_almost_equal
    assert round(abs(desired - actual),decimal) == 0, msg
AssertionError:
Items are not equal:
DESIRED: 0.0018833009350757682
ACTUAL: 1.0

======================================================================
FAIL: check_matvec (scipy.sparse.test_sparse.test_csc)
----------------------------------------------------------------------
Traceback (most recent call last):
  File 
"/data/home/u0038151/lib/python2.4/site-packages/scipy/sparse/tests/test_sparse.py", 
line 66, in check_matvec
    assert_array_almost_equal([1,2,3,4]*b,dot([1,2,3,4],b.todense()))
  File 
"/data/home/u0038151/lib/python2.4/site-packages/scipy/test/testing.py", 
line 727, in assert_array_almost_equal
    assert cond,\
AssertionError:
Arrays are not almost equal (mismatch 100.0%):
        Array 1: [ 0.  0.  0.]
        Array 2: [ 17.  14.   9.]


======================================================================
FAIL: check_matvec (scipy.sparse.test_sparse.test_csr)
----------------------------------------------------------------------
Traceback (most recent call last):
  File 
"/data/home/u0038151/lib/python2.4/site-packages/scipy/sparse/tests/test_sparse.py", 
line 66, in check_matvec
    assert_array_almost_equal([1,2,3,4]*b,dot([1,2,3,4],b.todense()))
  File 
"/data/home/u0038151/lib/python2.4/site-packages/scipy/test/testing.py", 
line 727, in assert_array_almost_equal
    assert cond,\
AssertionError:
Arrays are not almost equal (mismatch 100.0%):
        Array 1: [ 0.  0.  0.]
        Array 2: [ 17.  14.   9.]


======================================================================
FAIL: check_matvec (scipy.sparse.test_sparse.test_dok)
----------------------------------------------------------------------
Traceback (most recent call last):
  File 
"/data/home/u0038151/lib/python2.4/site-packages/scipy/sparse/tests/test_sparse.py", 
line 66, in check_matvec
    assert_array_almost_equal([1,2,3,4]*b,dot([1,2,3,4],b.todense()))
  File 
"/data/home/u0038151/lib/python2.4/site-packages/scipy/test/testing.py", 
line 727, in assert_array_almost_equal
    assert cond,\
AssertionError:
Arrays are not almost equal (mismatch 100.0%):
        Array 1: [ 0.  0.  0.]
        Array 2: [ 17.  14.   9.]


----------------------------------------------------------------------
Ran 1124 tests in 47.894s

FAILED (failures=38, errors=4)
<unittest.TextTestRunner object at 0x2aaab33bfad0>
 >>>


Disclaimer: http://www.kuleuven.be/cwis/email_disclaimer.htm




More information about the SciPy-User mailing list