[Scipy-svn] r3836 - in trunk/scipy: cluster/tests fftpack/tests integrate/tests interpolate/tests io/tests lib/blas/tests linalg/tests linsolve/umfpack/tests maxentropy/tests misc/tests ndimage/tests odr/tests optimize/tests sandbox/arpack/tests sandbox/delaunay/tests sandbox/dhuard/tests sandbox/exmplpackage/tests sandbox/fdfpack/tests sandbox/maskedarray/tests sandbox/montecarlo/tests sandbox/multigrid/gallery/tests sandbox/multigrid/tests sandbox/numexpr/tests sandbox/pyloess/tests sandbox/rbf/tests sandbox/spline/tests sandbox/timeseries/lib/tests sandbox/timeseries/tests signal/tests sparse/tests special/tests stats/models/tests stats/tests weave/tests

scipy-svn at scipy.org scipy-svn at scipy.org
Tue Jan 15 08:10:49 EST 2008


Author: matthew.brett at gmail.com
Date: 2008-01-15 07:09:03 -0600 (Tue, 15 Jan 2008)
New Revision: 3836

Modified:
   trunk/scipy/cluster/tests/test_vq.py
   trunk/scipy/fftpack/tests/test_basic.py
   trunk/scipy/fftpack/tests/test_helper.py
   trunk/scipy/fftpack/tests/test_pseudo_diffs.py
   trunk/scipy/integrate/tests/test_integrate.py
   trunk/scipy/integrate/tests/test_quadpack.py
   trunk/scipy/integrate/tests/test_quadrature.py
   trunk/scipy/interpolate/tests/test_fitpack.py
   trunk/scipy/interpolate/tests/test_interpolate.py
   trunk/scipy/io/tests/test_array_import.py
   trunk/scipy/io/tests/test_mmio.py
   trunk/scipy/io/tests/test_npfile.py
   trunk/scipy/io/tests/test_recaster.py
   trunk/scipy/lib/blas/tests/test_blas.py
   trunk/scipy/lib/blas/tests/test_fblas.py
   trunk/scipy/linalg/tests/test_basic.py
   trunk/scipy/linalg/tests/test_blas.py
   trunk/scipy/linalg/tests/test_decomp.py
   trunk/scipy/linalg/tests/test_fblas.py
   trunk/scipy/linalg/tests/test_iterative.py
   trunk/scipy/linalg/tests/test_lapack.py
   trunk/scipy/linalg/tests/test_matfuncs.py
   trunk/scipy/linsolve/umfpack/tests/test_umfpack.py
   trunk/scipy/maxentropy/tests/test_maxentropy.py
   trunk/scipy/misc/tests/test_pilutil.py
   trunk/scipy/ndimage/tests/test_ndimage.py
   trunk/scipy/odr/tests/test_odr.py
   trunk/scipy/optimize/tests/test_cobyla.py
   trunk/scipy/optimize/tests/test_nonlin.py
   trunk/scipy/optimize/tests/test_optimize.py
   trunk/scipy/optimize/tests/test_slsqp.py
   trunk/scipy/optimize/tests/test_zeros.py
   trunk/scipy/sandbox/arpack/tests/test_arpack.py
   trunk/scipy/sandbox/arpack/tests/test_speigs.py
   trunk/scipy/sandbox/delaunay/tests/test_triangulate.py
   trunk/scipy/sandbox/dhuard/tests/test_histogram.py
   trunk/scipy/sandbox/dhuard/tests/test_stats.py
   trunk/scipy/sandbox/exmplpackage/tests/test_foo.py
   trunk/scipy/sandbox/fdfpack/tests/test_fdf.py
   trunk/scipy/sandbox/maskedarray/tests/test_core.py
   trunk/scipy/sandbox/maskedarray/tests/test_extras.py
   trunk/scipy/sandbox/maskedarray/tests/test_morestats.py
   trunk/scipy/sandbox/maskedarray/tests/test_mrecords.py
   trunk/scipy/sandbox/maskedarray/tests/test_mstats.py
   trunk/scipy/sandbox/maskedarray/tests/test_subclassing.py
   trunk/scipy/sandbox/montecarlo/tests/test_dictsampler.py
   trunk/scipy/sandbox/montecarlo/tests/test_intsampler.py
   trunk/scipy/sandbox/multigrid/gallery/tests/test_elasticity.py
   trunk/scipy/sandbox/multigrid/gallery/tests/test_laplacian.py
   trunk/scipy/sandbox/multigrid/tests/test_adaptive.py
   trunk/scipy/sandbox/multigrid/tests/test_relaxation.py
   trunk/scipy/sandbox/multigrid/tests/test_sa.py
   trunk/scipy/sandbox/multigrid/tests/test_utils.py
   trunk/scipy/sandbox/numexpr/tests/test_numexpr.py
   trunk/scipy/sandbox/pyloess/tests/test_mpyloess.py
   trunk/scipy/sandbox/pyloess/tests/test_pyloess.py
   trunk/scipy/sandbox/rbf/tests/test_rbf.py
   trunk/scipy/sandbox/spline/tests/test_fitpack.py
   trunk/scipy/sandbox/spline/tests/test_spline.py
   trunk/scipy/sandbox/timeseries/lib/tests/test_interpolate.py
   trunk/scipy/sandbox/timeseries/lib/tests/test_moving_funcs.py
   trunk/scipy/sandbox/timeseries/tests/test_dates.py
   trunk/scipy/sandbox/timeseries/tests/test_extras.py
   trunk/scipy/sandbox/timeseries/tests/test_timeseries.py
   trunk/scipy/sandbox/timeseries/tests/test_trecords.py
   trunk/scipy/signal/tests/test_signaltools.py
   trunk/scipy/signal/tests/test_wavelets.py
   trunk/scipy/sparse/tests/test_base.py
   trunk/scipy/sparse/tests/test_construct.py
   trunk/scipy/sparse/tests/test_sputils.py
   trunk/scipy/special/tests/test_basic.py
   trunk/scipy/special/tests/test_spfun_stats.py
   trunk/scipy/stats/models/tests/test_bspline.py
   trunk/scipy/stats/models/tests/test_formula.py
   trunk/scipy/stats/models/tests/test_glm.py
   trunk/scipy/stats/models/tests/test_regression.py
   trunk/scipy/stats/models/tests/test_rlm.py
   trunk/scipy/stats/models/tests/test_scale.py
   trunk/scipy/stats/models/tests/test_utils.py
   trunk/scipy/stats/tests/test_distributions.py
   trunk/scipy/stats/tests/test_morestats.py
   trunk/scipy/stats/tests/test_stats.py
   trunk/scipy/weave/tests/test_ast_tools.py
   trunk/scipy/weave/tests/test_blitz_tools.py
   trunk/scipy/weave/tests/test_build_tools.py
   trunk/scipy/weave/tests/test_c_spec.py
   trunk/scipy/weave/tests/test_catalog.py
   trunk/scipy/weave/tests/test_ext_tools.py
   trunk/scipy/weave/tests/test_inline_tools.py
   trunk/scipy/weave/tests/test_numpy_scalar_spec.py
   trunk/scipy/weave/tests/test_scxx.py
   trunk/scipy/weave/tests/test_scxx_dict.py
   trunk/scipy/weave/tests/test_scxx_object.py
   trunk/scipy/weave/tests/test_scxx_sequence.py
   trunk/scipy/weave/tests/test_size_check.py
   trunk/scipy/weave/tests/test_slice_handler.py
   trunk/scipy/weave/tests/test_standard_array_spec.py
   trunk/scipy/weave/tests/test_wx_spec.py
Log:
nose running for individual test file exexecution

Modified: trunk/scipy/cluster/tests/test_vq.py
===================================================================
--- trunk/scipy/cluster/tests/test_vq.py	2008-01-15 11:51:10 UTC (rev 3835)
+++ trunk/scipy/cluster/tests/test_vq.py	2008-01-15 13:09:03 UTC (rev 3836)
@@ -145,4 +145,4 @@
         kmeans2(data, 3, minit = 'points')
 
 if __name__ == "__main__":
-    unittest.main()
+    nose.run(argv=['', __file__])

Modified: trunk/scipy/fftpack/tests/test_basic.py
===================================================================
--- trunk/scipy/fftpack/tests/test_basic.py	2008-01-15 11:51:10 UTC (rev 3835)
+++ trunk/scipy/fftpack/tests/test_basic.py	2008-01-15 13:09:03 UTC (rev 3836)
@@ -550,4 +550,4 @@
             assert_array_almost_equal (fftn(ifftn(x)),x)
 
 if __name__ == "__main__":
-    unittest.main()
+    nose.run(argv=['', __file__])

Modified: trunk/scipy/fftpack/tests/test_helper.py
===================================================================
--- trunk/scipy/fftpack/tests/test_helper.py	2008-01-15 11:51:10 UTC (rev 3835)
+++ trunk/scipy/fftpack/tests/test_helper.py	2008-01-15 13:09:03 UTC (rev 3836)
@@ -58,4 +58,4 @@
         assert_array_almost_equal(10*pi*rfftfreq(10,pi),x)
 
 if __name__ == "__main__":
-    unittest.main()
+    nose.run(argv=['', __file__])

Modified: trunk/scipy/fftpack/tests/test_pseudo_diffs.py
===================================================================
--- trunk/scipy/fftpack/tests/test_pseudo_diffs.py	2008-01-15 11:51:10 UTC (rev 3835)
+++ trunk/scipy/fftpack/tests/test_pseudo_diffs.py	2008-01-15 13:09:03 UTC (rev 3836)
@@ -432,4 +432,4 @@
             print ' (secs for %s calls)' % (repeat)
 
 if __name__ == "__main__":
-    unittest.main()
+    nose.run(argv=['', __file__])

Modified: trunk/scipy/integrate/tests/test_integrate.py
===================================================================
--- trunk/scipy/integrate/tests/test_integrate.py	2008-01-15 11:51:10 UTC (rev 3835)
+++ trunk/scipy/integrate/tests/test_integrate.py	2008-01-15 13:09:03 UTC (rev 3836)
@@ -49,4 +49,4 @@
         assert res < 1.0e-6
 
 if __name__ == "__main__":
-    unittest.main()
+    nose.run(argv=['', __file__])

Modified: trunk/scipy/integrate/tests/test_quadpack.py
===================================================================
--- trunk/scipy/integrate/tests/test_quadpack.py	2008-01-15 11:51:10 UTC (rev 3835)
+++ trunk/scipy/integrate/tests/test_quadpack.py	2008-01-15 13:09:03 UTC (rev 3836)
@@ -104,4 +104,4 @@
                     8/3.0 * (b**4.0 - a**4.0))
 
 if __name__ == "__main__":
-    unittest.main()
+    nose.run(argv=['', __file__])

Modified: trunk/scipy/integrate/tests/test_quadrature.py
===================================================================
--- trunk/scipy/integrate/tests/test_quadrature.py	2008-01-15 11:51:10 UTC (rev 3835)
+++ trunk/scipy/integrate/tests/test_quadrature.py	2008-01-15 13:09:03 UTC (rev 3836)
@@ -29,4 +29,4 @@
         assert_equal(romb(numpy.arange(17)),128)
 
 if __name__ == "__main__":
-    unittest.main()
+    nose.run(argv=['', __file__])

Modified: trunk/scipy/interpolate/tests/test_fitpack.py
===================================================================
--- trunk/scipy/interpolate/tests/test_fitpack.py	2008-01-15 11:51:10 UTC (rev 3835)
+++ trunk/scipy/interpolate/tests/test_fitpack.py	2008-01-15 13:09:03 UTC (rev 3836)
@@ -82,4 +82,4 @@
         assert_array_almost_equal(lut(x,y),z)
 
 if __name__ == "__main__":
-    unittest.main()
+    nose.run(argv=['', __file__])

Modified: trunk/scipy/interpolate/tests/test_interpolate.py
===================================================================
--- trunk/scipy/interpolate/tests/test_interpolate.py	2008-01-15 11:51:10 UTC (rev 3835)
+++ trunk/scipy/interpolate/tests/test_interpolate.py	2008-01-15 13:09:03 UTC (rev 3836)
@@ -200,4 +200,4 @@
 
 
 if __name__ == "__main__":
-    unittest.main()
+    nose.run(argv=['', __file__])

Modified: trunk/scipy/io/tests/test_array_import.py
===================================================================
--- trunk/scipy/io/tests/test_array_import.py	2008-01-15 11:51:10 UTC (rev 3835)
+++ trunk/scipy/io/tests/test_array_import.py	2008-01-15 13:09:03 UTC (rev 3836)
@@ -58,4 +58,4 @@
         os.remove(fname)
 
 if __name__ == "__main__":
-    unittest.main()
+    nose.run(argv=['', __file__])

Modified: trunk/scipy/io/tests/test_mmio.py
===================================================================
--- trunk/scipy/io/tests/test_mmio.py	2008-01-15 11:51:10 UTC (rev 3835)
+++ trunk/scipy/io/tests/test_mmio.py	2008-01-15 13:09:03 UTC (rev 3836)
@@ -292,4 +292,4 @@
         assert_array_almost_equal(a,b)
 
 if __name__ == "__main__":
-    unittest.main()
+    nose.run(argv=['', __file__])

Modified: trunk/scipy/io/tests/test_npfile.py
===================================================================
--- trunk/scipy/io/tests/test_npfile.py	2008-01-15 11:51:10 UTC (rev 3835)
+++ trunk/scipy/io/tests/test_npfile.py	2008-01-15 13:09:03 UTC (rev 3836)
@@ -102,4 +102,4 @@
         assert_array_equal(npf.read_array(adt, shp, order='C'), cf_arr)
 
 if __name__ == "__main__":
-    unittest.main()
+    nose.run(argv=['', __file__])

Modified: trunk/scipy/io/tests/test_recaster.py
===================================================================
--- trunk/scipy/io/tests/test_recaster.py	2008-01-15 11:51:10 UTC (rev 3835)
+++ trunk/scipy/io/tests/test_recaster.py	2008-01-15 13:09:03 UTC (rev 3836)
@@ -173,5 +173,5 @@
                    'Expected %s from %s, got %s' % (outp, inp, dtt)
             
 if __name__ == "__main__":
-    unittest.main()
+    nose.run(argv=['', __file__])
 

Modified: trunk/scipy/lib/blas/tests/test_blas.py
===================================================================
--- trunk/scipy/lib/blas/tests/test_blas.py	2008-01-15 11:51:10 UTC (rev 3835)
+++ trunk/scipy/lib/blas/tests/test_blas.py	2008-01-15 13:09:03 UTC (rev 3836)
@@ -223,4 +223,4 @@
 """
 
 if __name__ == "__main__":
-    unittest.main()
+    nose.run(argv=['', __file__])

Modified: trunk/scipy/lib/blas/tests/test_fblas.py
===================================================================
--- trunk/scipy/lib/blas/tests/test_fblas.py	2008-01-15 11:51:10 UTC (rev 3835)
+++ trunk/scipy/lib/blas/tests/test_fblas.py	2008-01-15 13:09:03 UTC (rev 3836)
@@ -522,4 +522,4 @@
 """
 
 if __name__ == "__main__":
-    unittest.main()
+    nose.run(argv=['', __file__])

Modified: trunk/scipy/linalg/tests/test_basic.py
===================================================================
--- trunk/scipy/linalg/tests/test_basic.py	2008-01-15 11:51:10 UTC (rev 3835)
+++ trunk/scipy/linalg/tests/test_basic.py	2008-01-15 13:09:03 UTC (rev 3836)
@@ -539,4 +539,4 @@
         assert_array_almost_equal(a_pinv,a_pinv2)
 
 if __name__ == "__main__":
-    unittest.main()
+    nose.run(argv=['', __file__])

Modified: trunk/scipy/linalg/tests/test_blas.py
===================================================================
--- trunk/scipy/linalg/tests/test_blas.py	2008-01-15 11:51:10 UTC (rev 3835)
+++ trunk/scipy/linalg/tests/test_blas.py	2008-01-15 13:09:03 UTC (rev 3836)
@@ -213,4 +213,4 @@
 """
 
 if __name__ == "__main__":
-    unittest.main()
+    nose.run(argv=['', __file__])

Modified: trunk/scipy/linalg/tests/test_decomp.py
===================================================================
--- trunk/scipy/linalg/tests/test_decomp.py	2008-01-15 11:51:10 UTC (rev 3835)
+++ trunk/scipy/linalg/tests/test_decomp.py	2008-01-15 13:09:03 UTC (rev 3836)
@@ -929,4 +929,4 @@
 
 
 if __name__ == "__main__":
-    unittest.main()
+    nose.run(argv=['', __file__])

Modified: trunk/scipy/linalg/tests/test_fblas.py
===================================================================
--- trunk/scipy/linalg/tests/test_fblas.py	2008-01-15 11:51:10 UTC (rev 3835)
+++ trunk/scipy/linalg/tests/test_fblas.py	2008-01-15 13:09:03 UTC (rev 3836)
@@ -525,4 +525,4 @@
 """
 
 if __name__ == "__main__":
-    unittest.main()
+    nose.run(argv=['', __file__])

Modified: trunk/scipy/linalg/tests/test_iterative.py
===================================================================
--- trunk/scipy/linalg/tests/test_iterative.py	2008-01-15 11:51:10 UTC (rev 3835)
+++ trunk/scipy/linalg/tests/test_iterative.py	2008-01-15 13:09:03 UTC (rev 3836)
@@ -80,4 +80,4 @@
         assert norm(dot(self.A, x) - self.b) < 5*self.tol
 
 if __name__ == "__main__":
-    unittest.main()
+    nose.run(argv=['', __file__])

Modified: trunk/scipy/linalg/tests/test_lapack.py
===================================================================
--- trunk/scipy/linalg/tests/test_lapack.py	2008-01-15 11:51:10 UTC (rev 3835)
+++ trunk/scipy/linalg/tests/test_lapack.py	2008-01-15 13:09:03 UTC (rev 3836)
@@ -68,4 +68,4 @@
 """
 
 if __name__ == "__main__":
-    unittest.main()
+    nose.run(argv=['', __file__])

Modified: trunk/scipy/linalg/tests/test_matfuncs.py
===================================================================
--- trunk/scipy/linalg/tests/test_matfuncs.py	2008-01-15 11:51:10 UTC (rev 3835)
+++ trunk/scipy/linalg/tests/test_matfuncs.py	2008-01-15 13:09:03 UTC (rev 3836)
@@ -98,4 +98,4 @@
         assert_array_almost_equal(expm3(a),[[1,0],[0,1]])
 
 if __name__ == "__main__":
-    unittest.main()
+    nose.run(argv=['', __file__])

Modified: trunk/scipy/linsolve/umfpack/tests/test_umfpack.py
===================================================================
--- trunk/scipy/linsolve/umfpack/tests/test_umfpack.py	2008-01-15 11:51:10 UTC (rev 3835)
+++ trunk/scipy/linsolve/umfpack/tests/test_umfpack.py	2008-01-15 13:09:03 UTC (rev 3836)
@@ -171,4 +171,4 @@
 
 
 if __name__ == "__main__":
-    unittest.main()
+    nose.run(argv=['', __file__])

Modified: trunk/scipy/maxentropy/tests/test_maxentropy.py
===================================================================
--- trunk/scipy/maxentropy/tests/test_maxentropy.py	2008-01-15 11:51:10 UTC (rev 3835)
+++ trunk/scipy/maxentropy/tests/test_maxentropy.py	2008-01-15 13:09:03 UTC (rev 3836)
@@ -36,4 +36,4 @@
 
 
 if __name__ == "__main__":
-    unittest.main()
+    nose.run(argv=['', __file__])

Modified: trunk/scipy/misc/tests/test_pilutil.py
===================================================================
--- trunk/scipy/misc/tests/test_pilutil.py	2008-01-15 11:51:10 UTC (rev 3835)
+++ trunk/scipy/misc/tests/test_pilutil.py	2008-01-15 13:09:03 UTC (rev 3836)
@@ -38,4 +38,4 @@
         yield tst_fromimage, os.path.join(datapath,'data',fn), irange
 
 if __name__ == "__main__":
-    unittest.main()
+    nose.run(argv=['', __file__])

Modified: trunk/scipy/ndimage/tests/test_ndimage.py
===================================================================
--- trunk/scipy/ndimage/tests/test_ndimage.py	2008-01-15 11:51:10 UTC (rev 3835)
+++ trunk/scipy/ndimage/tests/test_ndimage.py	2008-01-15 13:09:03 UTC (rev 3836)
@@ -5513,4 +5513,4 @@
 #    return len(result.failures), result.testsRun
 
 if __name__ == "__main__":
-    unittest.main()
+    nose.run(argv=['', __file__])

Modified: trunk/scipy/odr/tests/test_odr.py
===================================================================
--- trunk/scipy/odr/tests/test_odr.py	2008-01-15 11:51:10 UTC (rev 3835)
+++ trunk/scipy/odr/tests/test_odr.py	2008-01-15 13:09:03 UTC (rev 3836)
@@ -311,5 +311,5 @@
 
 
 if __name__ == "__main__":
-    unittest.main()
+    nose.run(argv=['', __file__])
 #### EOF #######################################################################

Modified: trunk/scipy/optimize/tests/test_cobyla.py
===================================================================
--- trunk/scipy/optimize/tests/test_cobyla.py	2008-01-15 11:51:10 UTC (rev 3835)
+++ trunk/scipy/optimize/tests/test_cobyla.py	2008-01-15 13:09:03 UTC (rev 3836)
@@ -18,4 +18,4 @@
         assert_almost_equal(x, [x0, x1], decimal=5)
 
 if __name__ == "__main__":
-    unittest.main()
+    nose.run(argv=['', __file__])

Modified: trunk/scipy/optimize/tests/test_nonlin.py
===================================================================
--- trunk/scipy/optimize/tests/test_nonlin.py	2008-01-15 11:51:10 UTC (rev 3835)
+++ trunk/scipy/optimize/tests/test_nonlin.py	2008-01-15 13:09:03 UTC (rev 3836)
@@ -91,4 +91,4 @@
 
 
 if __name__ == "__main__":
-    unittest.main()
+    nose.run(argv=['', __file__])

Modified: trunk/scipy/optimize/tests/test_optimize.py
===================================================================
--- trunk/scipy/optimize/tests/test_optimize.py	2008-01-15 11:51:10 UTC (rev 3835)
+++ trunk/scipy/optimize/tests/test_optimize.py	2008-01-15 13:09:03 UTC (rev 3836)
@@ -243,4 +243,4 @@
 
 
 if __name__ == "__main__":
-    unittest.main()
+    nose.run(argv=['', __file__])

Modified: trunk/scipy/optimize/tests/test_slsqp.py
===================================================================
--- trunk/scipy/optimize/tests/test_slsqp.py	2008-01-15 11:51:10 UTC (rev 3835)
+++ trunk/scipy/optimize/tests/test_slsqp.py	2008-01-15 13:09:03 UTC (rev 3836)
@@ -86,4 +86,4 @@
         assert_array_almost_equal(x,[2,1],decimal=3)
 
 if __name__ == "__main__":
-    unittest.main()
+    nose.run(argv=['', __file__])

Modified: trunk/scipy/optimize/tests/test_zeros.py
===================================================================
--- trunk/scipy/optimize/tests/test_zeros.py	2008-01-15 11:51:10 UTC (rev 3835)
+++ trunk/scipy/optimize/tests/test_zeros.py	2008-01-15 13:09:03 UTC (rev 3836)
@@ -93,4 +93,4 @@
             print '\n\n'
 
 if __name__ == '__main__' :
-    unittest.main()
+    nose.run(argv=['', __file__])

Modified: trunk/scipy/sandbox/arpack/tests/test_arpack.py
===================================================================
--- trunk/scipy/sandbox/arpack/tests/test_arpack.py	2008-01-15 11:51:10 UTC (rev 3835)
+++ trunk/scipy/sandbox/arpack/tests/test_arpack.py	2008-01-15 13:09:03 UTC (rev 3836)
@@ -349,4 +349,4 @@
 
 
 if __name__ == "__main__":
-    unittest.main()
+    nose.run(argv=['', __file__])

Modified: trunk/scipy/sandbox/arpack/tests/test_speigs.py
===================================================================
--- trunk/scipy/sandbox/arpack/tests/test_speigs.py	2008-01-15 11:51:10 UTC (rev 3835)
+++ trunk/scipy/sandbox/arpack/tests/test_speigs.py	2008-01-15 13:09:03 UTC (rev 3836)
@@ -48,4 +48,4 @@
 #          94.646308846854879, 95.30841709116271], decimal=11)
 
 if __name__ == "__main__":
-    unittest.main()
+    nose.run(argv=['', __file__])

Modified: trunk/scipy/sandbox/delaunay/tests/test_triangulate.py
===================================================================
--- trunk/scipy/sandbox/delaunay/tests/test_triangulate.py	2008-01-15 11:51:10 UTC (rev 3835)
+++ trunk/scipy/sandbox/delaunay/tests/test_triangulate.py	2008-01-15 13:09:03 UTC (rev 3836)
@@ -68,5 +68,5 @@
 
 
 if __name__ == '__main__':
-    unittest.main()
+    nose.run(argv=['', __file__])
     

Modified: trunk/scipy/sandbox/dhuard/tests/test_histogram.py
===================================================================
--- trunk/scipy/sandbox/dhuard/tests/test_histogram.py	2008-01-15 11:51:10 UTC (rev 3835)
+++ trunk/scipy/sandbox/dhuard/tests/test_histogram.py	2008-01-15 13:09:03 UTC (rev 3836)
@@ -96,4 +96,4 @@
 
 
 if __name__ == "__main__":
-    unittest.main()
+    nose.run(argv=['', __file__])

Modified: trunk/scipy/sandbox/dhuard/tests/test_stats.py
===================================================================
--- trunk/scipy/sandbox/dhuard/tests/test_stats.py	2008-01-15 11:51:10 UTC (rev 3835)
+++ trunk/scipy/sandbox/dhuard/tests/test_stats.py	2008-01-15 13:09:03 UTC (rev 3836)
@@ -41,4 +41,4 @@
 
 
 if __name__ == '__main__':
-    unittest.main()
+    nose.run(argv=['', __file__])

Modified: trunk/scipy/sandbox/exmplpackage/tests/test_foo.py
===================================================================
--- trunk/scipy/sandbox/exmplpackage/tests/test_foo.py	2008-01-15 11:51:10 UTC (rev 3835)
+++ trunk/scipy/sandbox/exmplpackage/tests/test_foo.py	2008-01-15 13:09:03 UTC (rev 3836)
@@ -16,21 +16,19 @@
 """
 
 import sys
-from numpy.test.testing import *
+from scipy.testing import *
 
-set_package_path()
-from exmplpackage.foo import *
-del sys.path[0]
+from scipy.sandbox.exmplpackage.foo import *
 
-class TestFooBar(NumpyTestCase):
+class TestFooBar(TestCase):
 
     def check_simple(self, level=1):
         assert exmplpackage_foo_bar()=='Hello from exmplpackage_foo_bar'
 
-class TestFooGun(NumpyTestCase):
+class TestFooGun(TestCase):
 
     def check_simple(self, level=1):
         assert foo_gun()=='Hello from foo_gun'
 
 if __name__ == "__main__":
-    NumpyTest().run()
+    nose.run(argv=['', __file__])

Modified: trunk/scipy/sandbox/fdfpack/tests/test_fdf.py
===================================================================
--- trunk/scipy/sandbox/fdfpack/tests/test_fdf.py	2008-01-15 11:51:10 UTC (rev 3835)
+++ trunk/scipy/sandbox/fdfpack/tests/test_fdf.py	2008-01-15 13:09:03 UTC (rev 3836)
@@ -29,4 +29,4 @@
                 assert_array_almost_equal(diff(sin(x),k=4,m=m)/n,sin(x)/n)
 
 if __name__ == "__main__":
-    unittest.main()
+    nose.run(argv=['', __file__])

Modified: trunk/scipy/sandbox/maskedarray/tests/test_core.py
===================================================================
--- trunk/scipy/sandbox/maskedarray/tests/test_core.py	2008-01-15 11:51:10 UTC (rev 3835)
+++ trunk/scipy/sandbox/maskedarray/tests/test_core.py	2008-01-15 13:09:03 UTC (rev 3836)
@@ -1313,4 +1313,4 @@
 ###############################################################################
 #------------------------------------------------------------------------------
 if __name__ == "__main__":
-    unittest.main()
+    nose.run(argv=['', __file__])

Modified: trunk/scipy/sandbox/maskedarray/tests/test_extras.py
===================================================================
--- trunk/scipy/sandbox/maskedarray/tests/test_extras.py	2008-01-15 11:51:10 UTC (rev 3835)
+++ trunk/scipy/sandbox/maskedarray/tests/test_extras.py	2008-01-15 13:09:03 UTC (rev 3836)
@@ -325,4 +325,4 @@
 ###############################################################################
 #------------------------------------------------------------------------------
 if __name__ == "__main__":
-    unittest.main()
+    nose.run(argv=['', __file__])

Modified: trunk/scipy/sandbox/maskedarray/tests/test_morestats.py
===================================================================
--- trunk/scipy/sandbox/maskedarray/tests/test_morestats.py	2008-01-15 11:51:10 UTC (rev 3835)
+++ trunk/scipy/sandbox/maskedarray/tests/test_morestats.py	2008-01-15 13:09:03 UTC (rev 3836)
@@ -106,4 +106,4 @@
 ###############################################################################
 #------------------------------------------------------------------------------
 if __name__ == "__main__":
-    unittest.main()
+    nose.run(argv=['', __file__])

Modified: trunk/scipy/sandbox/maskedarray/tests/test_mrecords.py
===================================================================
--- trunk/scipy/sandbox/maskedarray/tests/test_mrecords.py	2008-01-15 11:51:10 UTC (rev 3835)
+++ trunk/scipy/sandbox/maskedarray/tests/test_mrecords.py	2008-01-15 13:09:03 UTC (rev 3836)
@@ -173,4 +173,4 @@
 ###############################################################################
 #------------------------------------------------------------------------------
 if __name__ == "__main__":
-    unittest.main()
+    nose.run(argv=['', __file__])

Modified: trunk/scipy/sandbox/maskedarray/tests/test_mstats.py
===================================================================
--- trunk/scipy/sandbox/maskedarray/tests/test_mstats.py	2008-01-15 11:51:10 UTC (rev 3835)
+++ trunk/scipy/sandbox/maskedarray/tests/test_mstats.py	2008-01-15 13:09:03 UTC (rev 3836)
@@ -170,4 +170,4 @@
 ###############################################################################
 #------------------------------------------------------------------------------
 if __name__ == "__main__":
-    unittest.main()
+    nose.run(argv=['', __file__])

Modified: trunk/scipy/sandbox/maskedarray/tests/test_subclassing.py
===================================================================
--- trunk/scipy/sandbox/maskedarray/tests/test_subclassing.py	2008-01-15 11:51:10 UTC (rev 3835)
+++ trunk/scipy/sandbox/maskedarray/tests/test_subclassing.py	2008-01-15 13:09:03 UTC (rev 3836)
@@ -157,7 +157,7 @@
 
 ################################################################################
 if __name__ == '__main__':
-    unittest.main()
+    nose.run(argv=['', __file__])
     #
     if 0:
         x = array(arange(5), mask=[0]+[1]*4)

Modified: trunk/scipy/sandbox/montecarlo/tests/test_dictsampler.py
===================================================================
--- trunk/scipy/sandbox/montecarlo/tests/test_dictsampler.py	2008-01-15 11:51:10 UTC (rev 3835)
+++ trunk/scipy/sandbox/montecarlo/tests/test_dictsampler.py	2008-01-15 13:09:03 UTC (rev 3836)
@@ -73,4 +73,4 @@
 
 
 if __name__ == "__main__":
-    unittest.main()
+    nose.run(argv=['', __file__])

Modified: trunk/scipy/sandbox/montecarlo/tests/test_intsampler.py
===================================================================
--- trunk/scipy/sandbox/montecarlo/tests/test_intsampler.py	2008-01-15 11:51:10 UTC (rev 3835)
+++ trunk/scipy/sandbox/montecarlo/tests/test_intsampler.py	2008-01-15 13:09:03 UTC (rev 3836)
@@ -65,4 +65,4 @@
 
 
 if __name__ == "__main__":
-    unittest.main()
+    nose.run(argv=['', __file__])

Modified: trunk/scipy/sandbox/multigrid/gallery/tests/test_elasticity.py
===================================================================
--- trunk/scipy/sandbox/multigrid/gallery/tests/test_elasticity.py	2008-01-15 11:51:10 UTC (rev 3835)
+++ trunk/scipy/sandbox/multigrid/gallery/tests/test_elasticity.py	2008-01-15 13:09:03 UTC (rev 3836)
@@ -112,4 +112,4 @@
 
 
 if __name__ == '__main__':
-    unittest.main()
+    nose.run(argv=['', __file__])

Modified: trunk/scipy/sandbox/multigrid/gallery/tests/test_laplacian.py
===================================================================
--- trunk/scipy/sandbox/multigrid/gallery/tests/test_laplacian.py	2008-01-15 11:51:10 UTC (rev 3835)
+++ trunk/scipy/sandbox/multigrid/gallery/tests/test_laplacian.py	2008-01-15 13:09:03 UTC (rev 3836)
@@ -48,4 +48,4 @@
             assert_equal( poisson(grid).todense(), expected )
 
 if __name__ == '__main__':
-    unittest.main()
+    nose.run(argv=['', __file__])

Modified: trunk/scipy/sandbox/multigrid/tests/test_adaptive.py
===================================================================
--- trunk/scipy/sandbox/multigrid/tests/test_adaptive.py	2008-01-15 11:51:10 UTC (rev 3835)
+++ trunk/scipy/sandbox/multigrid/tests/test_adaptive.py	2008-01-15 13:09:03 UTC (rev 3836)
@@ -63,4 +63,4 @@
 #
 
 if __name__ == '__main__':
-    unittest.main()
+    nose.run(argv=['', __file__])

Modified: trunk/scipy/sandbox/multigrid/tests/test_relaxation.py
===================================================================
--- trunk/scipy/sandbox/multigrid/tests/test_relaxation.py	2008-01-15 11:51:10 UTC (rev 3835)
+++ trunk/scipy/sandbox/multigrid/tests/test_relaxation.py	2008-01-15 13:09:03 UTC (rev 3836)
@@ -158,4 +158,4 @@
         self.assert_(allclose(resid1,resid2))
 
 if __name__ == '__main__':
-    unittest.main()
+    nose.run(argv=['', __file__])

Modified: trunk/scipy/sandbox/multigrid/tests/test_sa.py
===================================================================
--- trunk/scipy/sandbox/multigrid/tests/test_sa.py	2008-01-15 11:51:10 UTC (rev 3835)
+++ trunk/scipy/sandbox/multigrid/tests/test_sa.py	2008-01-15 13:09:03 UTC (rev 3836)
@@ -311,4 +311,4 @@
 
 
 if __name__ == '__main__':
-    unittest.main()
+    nose.run(argv=['', __file__])

Modified: trunk/scipy/sandbox/multigrid/tests/test_utils.py
===================================================================
--- trunk/scipy/sandbox/multigrid/tests/test_utils.py	2008-01-15 11:51:10 UTC (rev 3835)
+++ trunk/scipy/sandbox/multigrid/tests/test_utils.py	2008-01-15 13:09:03 UTC (rev 3836)
@@ -104,4 +104,4 @@
 
 
 if __name__ == '__main__':
-    unittest.main()
+    nose.run(argv=['', __file__])

Modified: trunk/scipy/sandbox/numexpr/tests/test_numexpr.py
===================================================================
--- trunk/scipy/sandbox/numexpr/tests/test_numexpr.py	2008-01-15 11:51:10 UTC (rev 3835)
+++ trunk/scipy/sandbox/numexpr/tests/test_numexpr.py	2008-01-15 13:09:03 UTC (rev 3836)
@@ -448,4 +448,4 @@
 
 
 if __name__ == '__main__':
-    unittest.main()
+    nose.run(argv=['', __file__])

Modified: trunk/scipy/sandbox/pyloess/tests/test_mpyloess.py
===================================================================
--- trunk/scipy/sandbox/pyloess/tests/test_mpyloess.py	2008-01-15 11:51:10 UTC (rev 3835)
+++ trunk/scipy/sandbox/pyloess/tests/test_mpyloess.py	2008-01-15 13:09:03 UTC (rev 3836)
@@ -430,4 +430,4 @@
 
 ########################################################################
 if __name__ == '__main__':
-    unittest.main()
+    nose.run(argv=['', __file__])

Modified: trunk/scipy/sandbox/pyloess/tests/test_pyloess.py
===================================================================
--- trunk/scipy/sandbox/pyloess/tests/test_pyloess.py	2008-01-15 11:51:10 UTC (rev 3835)
+++ trunk/scipy/sandbox/pyloess/tests/test_pyloess.py	2008-01-15 13:09:03 UTC (rev 3836)
@@ -383,4 +383,4 @@
 
 ########################################################################
 if __name__ == '__main__':
-    unittest.main()
+    nose.run(argv=['', __file__])

Modified: trunk/scipy/sandbox/rbf/tests/test_rbf.py
===================================================================
--- trunk/scipy/sandbox/rbf/tests/test_rbf.py	2008-01-15 11:51:10 UTC (rev 3835)
+++ trunk/scipy/sandbox/rbf/tests/test_rbf.py	2008-01-15 13:09:03 UTC (rev 3836)
@@ -39,4 +39,4 @@
         assert_array_almost_equal(di, d)
 
 if __name__ == "__main__":
-    unittest.main()
+    nose.run(argv=['', __file__])

Modified: trunk/scipy/sandbox/spline/tests/test_fitpack.py
===================================================================
--- trunk/scipy/sandbox/spline/tests/test_fitpack.py	2008-01-15 11:51:10 UTC (rev 3835)
+++ trunk/scipy/sandbox/spline/tests/test_fitpack.py	2008-01-15 13:09:03 UTC (rev 3836)
@@ -239,4 +239,4 @@
                         around(abs(splev(uv[0],tck)-f(uv[0])),2),decimal=1)
 
 if __name__ == "__main__":
-    unittest.main()
+    nose.run(argv=['', __file__])

Modified: trunk/scipy/sandbox/spline/tests/test_spline.py
===================================================================
--- trunk/scipy/sandbox/spline/tests/test_spline.py	2008-01-15 11:51:10 UTC (rev 3835)
+++ trunk/scipy/sandbox/spline/tests/test_spline.py	2008-01-15 13:09:03 UTC (rev 3836)
@@ -162,4 +162,4 @@
         assert_array_almost_equal(lut(x,y),z)
 
 if __name__ == "__main__":
-    unittest.main()
+    nose.run(argv=['', __file__])

Modified: trunk/scipy/sandbox/timeseries/lib/tests/test_interpolate.py
===================================================================
--- trunk/scipy/sandbox/timeseries/lib/tests/test_interpolate.py	2008-01-15 11:51:10 UTC (rev 3835)
+++ trunk/scipy/sandbox/timeseries/lib/tests/test_interpolate.py	2008-01-15 13:09:03 UTC (rev 3836)
@@ -61,4 +61,4 @@
 ###############################################################################
 #------------------------------------------------------------------------------
 if __name__ == "__main__":
-    unittest.main()
+    nose.run(argv=['', __file__])

Modified: trunk/scipy/sandbox/timeseries/lib/tests/test_moving_funcs.py
===================================================================
--- trunk/scipy/sandbox/timeseries/lib/tests/test_moving_funcs.py	2008-01-15 11:51:10 UTC (rev 3835)
+++ trunk/scipy/sandbox/timeseries/lib/tests/test_moving_funcs.py	2008-01-15 13:09:03 UTC (rev 3836)
@@ -149,4 +149,4 @@
 
 #------------------------------------------------------------------------------
 if __name__ == "__main__":
-    unittest.main()
+    nose.run(argv=['', __file__])

Modified: trunk/scipy/sandbox/timeseries/tests/test_dates.py
===================================================================
--- trunk/scipy/sandbox/timeseries/tests/test_dates.py	2008-01-15 11:51:10 UTC (rev 3835)
+++ trunk/scipy/sandbox/timeseries/tests/test_dates.py	2008-01-15 13:09:03 UTC (rev 3836)
@@ -882,4 +882,4 @@
 ###############################################################################
 #------------------------------------------------------------------------------
 if __name__ == "__main__":
-    unittest.main()
+    nose.run(argv=['', __file__])

Modified: trunk/scipy/sandbox/timeseries/tests/test_extras.py
===================================================================
--- trunk/scipy/sandbox/timeseries/tests/test_extras.py	2008-01-15 11:51:10 UTC (rev 3835)
+++ trunk/scipy/sandbox/timeseries/tests/test_extras.py	2008-01-15 13:09:03 UTC (rev 3836)
@@ -80,4 +80,4 @@
 ###############################################################################
 #------------------------------------------------------------------------------
 if __name__ == "__main__":
-    unittest.main()
+    nose.run(argv=['', __file__])

Modified: trunk/scipy/sandbox/timeseries/tests/test_timeseries.py
===================================================================
--- trunk/scipy/sandbox/timeseries/tests/test_timeseries.py	2008-01-15 11:51:10 UTC (rev 3835)
+++ trunk/scipy/sandbox/timeseries/tests/test_timeseries.py	2008-01-15 13:09:03 UTC (rev 3836)
@@ -632,4 +632,4 @@
 ###############################################################################
 #------------------------------------------------------------------------------
 if __name__ == "__main__":
-    unittest.main()
+    nose.run(argv=['', __file__])

Modified: trunk/scipy/sandbox/timeseries/tests/test_trecords.py
===================================================================
--- trunk/scipy/sandbox/timeseries/tests/test_trecords.py	2008-01-15 11:51:10 UTC (rev 3835)
+++ trunk/scipy/sandbox/timeseries/tests/test_trecords.py	2008-01-15 13:09:03 UTC (rev 3836)
@@ -184,4 +184,4 @@
 ###############################################################################
 #------------------------------------------------------------------------------
 if __name__ == "__main__":
-    unittest.main()
+    nose.run(argv=['', __file__])

Modified: trunk/scipy/signal/tests/test_signaltools.py
===================================================================
--- trunk/scipy/signal/tests/test_signaltools.py	2008-01-15 11:51:10 UTC (rev 3835)
+++ trunk/scipy/signal/tests/test_signaltools.py	2008-01-15 13:09:03 UTC (rev 3836)
@@ -46,4 +46,4 @@
                            [2,3,2])
 
 if __name__ == "__main__":
-    unittest.main()
+    nose.run(argv=['', __file__])

Modified: trunk/scipy/signal/tests/test_wavelets.py
===================================================================
--- trunk/scipy/signal/tests/test_wavelets.py	2008-01-15 11:51:10 UTC (rev 3835)
+++ trunk/scipy/signal/tests/test_wavelets.py	2008-01-15 13:09:03 UTC (rev 3836)
@@ -31,4 +31,4 @@
         assert_equal(x,y)
 
 if __name__ == "__main__":
-    unittest.main()
+    nose.run(argv=['', __file__])

Modified: trunk/scipy/sparse/tests/test_base.py
===================================================================
--- trunk/scipy/sparse/tests/test_base.py	2008-01-15 11:51:10 UTC (rev 3835)
+++ trunk/scipy/sparse/tests/test_base.py	2008-01-15 13:09:03 UTC (rev 3836)
@@ -1295,4 +1295,4 @@
 
                 
 if __name__ == "__main__":
-    unittest.main()
+    nose.run(argv=['', __file__])

Modified: trunk/scipy/sparse/tests/test_construct.py
===================================================================
--- trunk/scipy/sparse/tests/test_construct.py	2008-01-15 11:51:10 UTC (rev 3835)
+++ trunk/scipy/sparse/tests/test_construct.py	2008-01-15 13:09:03 UTC (rev 3836)
@@ -133,5 +133,5 @@
                             [6,5,0]])
 
 if __name__ == "__main__":
-    unittest.main()
+    nose.run(argv=['', __file__])
 

Modified: trunk/scipy/sparse/tests/test_sputils.py
===================================================================
--- trunk/scipy/sparse/tests/test_sputils.py	2008-01-15 11:51:10 UTC (rev 3835)
+++ trunk/scipy/sparse/tests/test_sputils.py	2008-01-15 13:09:03 UTC (rev 3836)
@@ -67,6 +67,6 @@
         assert_equal(isdense( np.matrix([1]) ),True)
                 
 if __name__ == "__main__":
-    unittest.main()
+    nose.run(argv=['', __file__])
 
 

Modified: trunk/scipy/special/tests/test_basic.py
===================================================================
--- trunk/scipy/special/tests/test_basic.py	2008-01-15 11:51:10 UTC (rev 3835)
+++ trunk/scipy/special/tests/test_basic.py	2008-01-15 13:09:03 UTC (rev 3836)
@@ -1887,4 +1887,4 @@
         assert_almost_equal(sy3,sphpy,4) #compare correct derivative val. (correct =-system val).
 
 if __name__ == "__main__":
-    unittest.main()
+    nose.run(argv=['', __file__])

Modified: trunk/scipy/special/tests/test_spfun_stats.py
===================================================================
--- trunk/scipy/special/tests/test_spfun_stats.py	2008-01-15 11:51:10 UTC (rev 3835)
+++ trunk/scipy/special/tests/test_spfun_stats.py	2008-01-15 13:09:03 UTC (rev 3836)
@@ -35,4 +35,4 @@
             pass
 
 if __name__ == '__main__':
-    unittest.main()
+    nose.run(argv=['', __file__])

Modified: trunk/scipy/stats/models/tests/test_bspline.py
===================================================================
--- trunk/scipy/stats/models/tests/test_bspline.py	2008-01-15 11:51:10 UTC (rev 3835)
+++ trunk/scipy/stats/models/tests/test_bspline.py	2008-01-15 13:09:03 UTC (rev 3836)
@@ -20,4 +20,4 @@
 
 
 if __name__ == "__main__":
-    unittest.main()
+    nose.run(argv=['', __file__])

Modified: trunk/scipy/stats/models/tests/test_formula.py
===================================================================
--- trunk/scipy/stats/models/tests/test_formula.py	2008-01-15 11:51:10 UTC (rev 3835)
+++ trunk/scipy/stats/models/tests/test_formula.py	2008-01-15 13:09:03 UTC (rev 3836)
@@ -227,4 +227,4 @@
         self.assertEquals(estimable, False)
 
 if __name__ == "__main__":
-    unittest.main()
+    nose.run(argv=['', __file__])

Modified: trunk/scipy/stats/models/tests/test_glm.py
===================================================================
--- trunk/scipy/stats/models/tests/test_glm.py	2008-01-15 11:51:10 UTC (rev 3835)
+++ trunk/scipy/stats/models/tests/test_glm.py	2008-01-15 13:09:03 UTC (rev 3836)
@@ -31,4 +31,4 @@
         self.assertEquals(results.df_resid, 31)
 
 if __name__ == "__main__":
-    unittest.main()
+    nose.run(argv=['', __file__])

Modified: trunk/scipy/stats/models/tests/test_regression.py
===================================================================
--- trunk/scipy/stats/models/tests/test_regression.py	2008-01-15 11:51:10 UTC (rev 3835)
+++ trunk/scipy/stats/models/tests/test_regression.py	2008-01-15 13:09:03 UTC (rev 3836)
@@ -42,4 +42,4 @@
         self.assertEquals(results.df_resid, 31)
 
 if __name__ == "__main__":
-    unittest.main()
+    nose.run(argv=['', __file__])

Modified: trunk/scipy/stats/models/tests/test_rlm.py
===================================================================
--- trunk/scipy/stats/models/tests/test_rlm.py	2008-01-15 11:51:10 UTC (rev 3835)
+++ trunk/scipy/stats/models/tests/test_rlm.py	2008-01-15 13:09:03 UTC (rev 3836)
@@ -27,4 +27,4 @@
         self.assertEquals(results.df_resid, 31)
 
 if __name__ == "__main__":
-    unittest.main()
+    nose.run(argv=['', __file__])

Modified: trunk/scipy/stats/models/tests/test_scale.py
===================================================================
--- trunk/scipy/stats/models/tests/test_scale.py	2008-01-15 11:51:10 UTC (rev 3835)
+++ trunk/scipy/stats/models/tests/test_scale.py	2008-01-15 13:09:03 UTC (rev 3836)
@@ -50,4 +50,4 @@
         self.assertEquals(m.shape, (40,10))
 
 if __name__ == "__main__":
-    unittest.main()
+    nose.run(argv=['', __file__])

Modified: trunk/scipy/stats/models/tests/test_utils.py
===================================================================
--- trunk/scipy/stats/models/tests/test_utils.py	2008-01-15 11:51:10 UTC (rev 3835)
+++ trunk/scipy/stats/models/tests/test_utils.py	2008-01-15 13:09:03 UTC (rev 3836)
@@ -55,4 +55,4 @@
         self.assertRaises(ValueError, utils.StepFunction, x, y)
 
 if __name__ == "__main__":
-    unittest.main()
+    nose.run(argv=['', __file__])

Modified: trunk/scipy/stats/tests/test_distributions.py
===================================================================
--- trunk/scipy/stats/tests/test_distributions.py	2008-01-15 11:51:10 UTC (rev 3835)
+++ trunk/scipy/stats/tests/test_distributions.py	2008-01-15 13:09:03 UTC (rev 3836)
@@ -213,4 +213,4 @@
         assert_equal(stats.expon.pdf(0),1)
 
 if __name__ == "__main__":
-    unittest.main()
+    nose.run(argv=['', __file__])

Modified: trunk/scipy/stats/tests/test_morestats.py
===================================================================
--- trunk/scipy/stats/tests/test_morestats.py	2008-01-15 11:51:10 UTC (rev 3835)
+++ trunk/scipy/stats/tests/test_morestats.py	2008-01-15 13:09:03 UTC (rev 3836)
@@ -111,4 +111,4 @@
         assert_array_equal(nums,[3,3,2,2])
 
 if __name__ == "__main__":
-    unittest.main()
+    nose.run(argv=['', __file__])

Modified: trunk/scipy/stats/tests/test_stats.py
===================================================================
--- trunk/scipy/stats/tests/test_stats.py	2008-01-15 11:51:10 UTC (rev 3835)
+++ trunk/scipy/stats/tests/test_stats.py	2008-01-15 13:09:03 UTC (rev 3836)
@@ -845,4 +845,4 @@
                            [0,2,3,4,0,0,0])
 
 if __name__ == "__main__":
-    unittest.main()
+    nose.run(argv=['', __file__])

Modified: trunk/scipy/weave/tests/test_ast_tools.py
===================================================================
--- trunk/scipy/weave/tests/test_ast_tools.py	2008-01-15 11:51:10 UTC (rev 3835)
+++ trunk/scipy/weave/tests/test_ast_tools.py	2008-01-15 13:09:03 UTC (rev 3836)
@@ -26,4 +26,4 @@
         self.generic_check(expr,desired)
 
 if __name__ == "__main__":
-    unittest.main()
+    nose.run(argv=['', __file__])

Modified: trunk/scipy/weave/tests/test_blitz_tools.py
===================================================================
--- trunk/scipy/weave/tests/test_blitz_tools.py	2008-01-15 11:51:10 UTC (rev 3835)
+++ trunk/scipy/weave/tests/test_blitz_tools.py	2008-01-15 13:09:03 UTC (rev 3836)
@@ -181,4 +181,4 @@
         self.generic_2d(expr,complex128)
 
 if __name__ == "__main__":
-    unittest.main()
+    nose.run(argv=['', __file__])

Modified: trunk/scipy/weave/tests/test_build_tools.py
===================================================================
--- trunk/scipy/weave/tests/test_build_tools.py	2008-01-15 11:51:10 UTC (rev 3835)
+++ trunk/scipy/weave/tests/test_build_tools.py	2008-01-15 13:09:03 UTC (rev 3836)
@@ -62,4 +62,4 @@
         assert(pre_argv == sys.argv[:])
 
 if __name__ == "__main__":
-    unittest.main()
+    nose.run(argv=['', __file__])

Modified: trunk/scipy/weave/tests/test_c_spec.py
===================================================================
--- trunk/scipy/weave/tests/test_c_spec.py	2008-01-15 11:51:10 UTC (rev 3835)
+++ trunk/scipy/weave/tests/test_c_spec.py	2008-01-15 13:09:03 UTC (rev 3836)
@@ -757,4 +757,4 @@
 #         if _n[:7]=='TestGcc': exec 'del '+_n
 # 
 if __name__ == "__main__":
-    unittest.main()
+    nose.run(argv=['', __file__])

Modified: trunk/scipy/weave/tests/test_catalog.py
===================================================================
--- trunk/scipy/weave/tests/test_catalog.py	2008-01-15 11:51:10 UTC (rev 3835)
+++ trunk/scipy/weave/tests/test_catalog.py	2008-01-15 13:09:03 UTC (rev 3836)
@@ -331,4 +331,4 @@
 
 
 if __name__ == '__main__':
-    unittest.main()
+    nose.run(argv=['', __file__])

Modified: trunk/scipy/weave/tests/test_ext_tools.py
===================================================================
--- trunk/scipy/weave/tests/test_ext_tools.py	2008-01-15 11:51:10 UTC (rev 3835)
+++ trunk/scipy/weave/tests/test_ext_tools.py	2008-01-15 13:09:03 UTC (rev 3836)
@@ -141,4 +141,4 @@
         print_assert_equal(expr,actual,desired)
 
 if __name__ == "__main__":
-    unittest.main()
+    nose.run(argv=['', __file__])

Modified: trunk/scipy/weave/tests/test_inline_tools.py
===================================================================
--- trunk/scipy/weave/tests/test_inline_tools.py	2008-01-15 11:51:10 UTC (rev 3835)
+++ trunk/scipy/weave/tests/test_inline_tools.py	2008-01-15 13:09:03 UTC (rev 3836)
@@ -44,4 +44,4 @@
             pass
 
 if __name__ == "__main__":
-    unittest.main()
+    nose.run(argv=['', __file__])

Modified: trunk/scipy/weave/tests/test_numpy_scalar_spec.py
===================================================================
--- trunk/scipy/weave/tests/test_numpy_scalar_spec.py	2008-01-15 11:51:10 UTC (rev 3835)
+++ trunk/scipy/weave/tests/test_numpy_scalar_spec.py	2008-01-15 13:09:03 UTC (rev 3836)
@@ -168,4 +168,4 @@
         if _n[:7]=='TestGcc': exec 'del '+_n
 
 if __name__ == "__main__":
-    unittest.main()
+    nose.run(argv=['', __file__])

Modified: trunk/scipy/weave/tests/test_scxx.py
===================================================================
--- trunk/scipy/weave/tests/test_scxx.py	2008-01-15 11:51:10 UTC (rev 3835)
+++ trunk/scipy/weave/tests/test_scxx.py	2008-01-15 13:09:03 UTC (rev 3836)
@@ -12,4 +12,4 @@
 
 
 if __name__ == "__main__":
-    unittest.main()
+    nose.run(argv=['', __file__])

Modified: trunk/scipy/weave/tests/test_scxx_dict.py
===================================================================
--- trunk/scipy/weave/tests/test_scxx_dict.py	2008-01-15 11:51:10 UTC (rev 3835)
+++ trunk/scipy/weave/tests/test_scxx_dict.py	2008-01-15 13:09:03 UTC (rev 3836)
@@ -298,4 +298,4 @@
         assert a == b
 
 if __name__ == "__main__":
-    unittest.main()
+    nose.run(argv=['', __file__])

Modified: trunk/scipy/weave/tests/test_scxx_object.py
===================================================================
--- trunk/scipy/weave/tests/test_scxx_object.py	2008-01-15 11:51:10 UTC (rev 3835)
+++ trunk/scipy/weave/tests/test_scxx_object.py	2008-01-15 13:09:03 UTC (rev 3836)
@@ -900,4 +900,4 @@
         assert_equal(a['first'],a['second'])
 
 if __name__ == "__main__":
-    unittest.main()
+    nose.run(argv=['', __file__])

Modified: trunk/scipy/weave/tests/test_scxx_sequence.py
===================================================================
--- trunk/scipy/weave/tests/test_scxx_sequence.py	2008-01-15 11:51:10 UTC (rev 3835)
+++ trunk/scipy/weave/tests/test_scxx_sequence.py	2008-01-15 13:09:03 UTC (rev 3836)
@@ -452,4 +452,4 @@
         assert b == desired
 
 if __name__ == "__main__":
-    unittest.main()
+    nose.run(argv=['', __file__])

Modified: trunk/scipy/weave/tests/test_size_check.py
===================================================================
--- trunk/scipy/weave/tests/test_size_check.py	2008-01-15 11:51:10 UTC (rev 3835)
+++ trunk/scipy/weave/tests/test_size_check.py	2008-01-15 13:09:03 UTC (rev 3836)
@@ -370,4 +370,4 @@
 
 
 if __name__ == "__main__":
-    unittest.main()
+    nose.run(argv=['', __file__])

Modified: trunk/scipy/weave/tests/test_slice_handler.py
===================================================================
--- trunk/scipy/weave/tests/test_slice_handler.py	2008-01-15 11:51:10 UTC (rev 3835)
+++ trunk/scipy/weave/tests/test_slice_handler.py	2008-01-15 13:09:03 UTC (rev 3836)
@@ -162,4 +162,4 @@
 
 
 if __name__ == "__main__":
-    unittest.main()
+    nose.run(argv=['', __file__])

Modified: trunk/scipy/weave/tests/test_standard_array_spec.py
===================================================================
--- trunk/scipy/weave/tests/test_standard_array_spec.py	2008-01-15 11:51:10 UTC (rev 3835)
+++ trunk/scipy/weave/tests/test_standard_array_spec.py	2008-01-15 13:09:03 UTC (rev 3836)
@@ -38,4 +38,4 @@
         assert(s.type_match(arange(4)))
 
 if __name__ == "__main__":
-    unittest.main()
+    nose.run(argv=['', __file__])

Modified: trunk/scipy/weave/tests/test_wx_spec.py
===================================================================
--- trunk/scipy/weave/tests/test_wx_spec.py	2008-01-15 11:51:10 UTC (rev 3835)
+++ trunk/scipy/weave/tests/test_wx_spec.py	2008-01-15 13:09:03 UTC (rev 3836)
@@ -108,4 +108,4 @@
         assert(c == 'hello')
 
 if __name__ == "__main__":
-    unittest.main()
+    nose.run(argv=['', __file__])




More information about the Scipy-svn mailing list