Mock Version: 1.3.4 Mock Version: 1.3.4 ENTER ['do'](['bash', '--login', '-c', '/usr/bin/rpmbuild -bs --target ppc64le --nodeps /builddir/build/SPECS/scipy.spec'], nspawn_args=[]shell=Falseuid=996env={'LANG': 'en_GB.UTF-8', 'TERM': 'vt100', 'SHELL': '/bin/bash', 'HOSTNAME': 'mock', 'PROMPT_COMMAND': 'printf "\\033]0;\\007"', 'HOME': '/builddir', 'PATH': '/usr/bin:/bin:/usr/sbin:/sbin', 'PS1': ' \\s-\\v\\$ '}chrootPath='/var/lib/mock/module-python27-2.7-8030020200723193243-851f4228-build-52212-10779/root'gid=135user='mockbuild'timeout=86400logger=printOutput=False) Executing command: ['bash', '--login', '-c', '/usr/bin/rpmbuild -bs --target ppc64le --nodeps /builddir/build/SPECS/scipy.spec'] with env {'LANG': 'en_GB.UTF-8', 'TERM': 'vt100', 'SHELL': '/bin/bash', 'HOSTNAME': 'mock', 'PROMPT_COMMAND': 'printf "\\033]0;\\007"', 'HOME': '/builddir', 'PATH': '/usr/bin:/bin:/usr/sbin:/sbin', 'PS1': ' \\s-\\v\\$ '} and shell False Building target platforms: ppc64le Building for target ppc64le Wrote: /builddir/build/SRPMS/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.src.rpm Child return code was: 0 ENTER ['do'](['bash', '--login', '-c', u'/usr/bin/rpmbuild -bb --target ppc64le --nodeps /builddir/build/SPECS/scipy.spec'], nspawn_args=[]shell=Falseuid=996env={'LANG': 'en_GB.UTF-8', 'TERM': 'vt100', 'SHELL': '/bin/bash', 'HOSTNAME': 'mock', 'PROMPT_COMMAND': 'printf "\\033]0;\\007"', 'HOME': '/builddir', 'PATH': '/usr/bin:/bin:/usr/sbin:/sbin', 'PS1': ' \\s-\\v\\$ '}chrootPath='/var/lib/mock/module-python27-2.7-8030020200723193243-851f4228-build-52212-10779/root'gid=135user='mockbuild'timeout=86400logger=printOutput=False) Executing command: ['bash', '--login', '-c', u'/usr/bin/rpmbuild -bb --target ppc64le --nodeps /builddir/build/SPECS/scipy.spec'] with env {'LANG': 'en_GB.UTF-8', 'TERM': 'vt100', 'SHELL': '/bin/bash', 'HOSTNAME': 'mock', 'PROMPT_COMMAND': 'printf "\\033]0;\\007"', 'HOME': '/builddir', 'PATH': '/usr/bin:/bin:/usr/sbin:/sbin', 'PS1': ' \\s-\\v\\$ '} and shell False Building target platforms: ppc64le Building for target ppc64le Executing(%prep): /bin/sh -e /var/tmp/rpm-tmp.MK2A1F + umask 022 + cd /builddir/build/BUILD + cd /builddir/build/BUILD + rm -rf scipy-1.0.0 + /usr/bin/xz -dc /builddir/build/SOURCES/scipy-1.0.0.tar.xz + /usr/bin/tar -xof - + STATUS=0 + '[' 0 -ne 0 ']' + cd scipy-1.0.0 + /usr/bin/chmod -Rf a+rX,u+w,g-w,o-w . Patch #0 (scipy-1.0.0-six.patch): + echo 'Patch #0 (scipy-1.0.0-six.patch):' + /usr/bin/patch --no-backup-if-mismatch -p1 --fuzz=0 patching file scipy/_lib/_version.py patching file scipy/_lib/six.py patching file scipy/cluster/hierarchy.py patching file scipy/cluster/tests/test_hierarchy.py patching file scipy/cluster/vq.py patching file scipy/integrate/quadrature.py patching file scipy/integrate/tests/test_integrate.py patching file scipy/integrate/tests/test_quadpack.py patching file scipy/interpolate/_cubic.py patching file scipy/interpolate/interpolate.py patching file scipy/interpolate/polyint.py patching file scipy/interpolate/rbf.py patching file scipy/interpolate/tests/test_interpolate.py patching file scipy/interpolate/tests/test_polyint.py patching file scipy/io/arff/arffread.py patching file scipy/io/harwell_boeing/hb.py patching file scipy/io/matlab/mio.py patching file scipy/io/matlab/mio4.py patching file scipy/io/matlab/mio5.py patching file scipy/io/matlab/miobase.py patching file scipy/io/matlab/tests/test_mio.py patching file scipy/io/matlab/tests/test_mio5_utils.py patching file scipy/io/mmio.py patching file scipy/io/netcdf.py patching file scipy/linalg/_decomp_qz.py patching file scipy/linalg/decomp.py patching file scipy/linalg/decomp_schur.py patching file scipy/linalg/decomp_svd.py patching file scipy/linalg/special_matrices.py patching file scipy/linalg/tests/test_decomp.py patching file scipy/linalg/tests/test_fblas.py patching file scipy/linalg/tests/test_special_matrices.py patching file scipy/ndimage/_ni_support.py patching file scipy/optimize/_differentialevolution.py patching file scipy/optimize/_lsq/dogbox.py patching file scipy/optimize/_lsq/least_squares.py patching file scipy/optimize/_lsq/trf.py patching file scipy/optimize/_minimize.py patching file scipy/optimize/_root.py patching file scipy/optimize/cobyla.py patching file scipy/optimize/linesearch.py patching file scipy/optimize/nonlin.py patching file scipy/optimize/optimize.py patching file scipy/optimize/tests/test_nonlin.py patching file scipy/signal/_peak_finding.py patching file scipy/signal/bsplines.py patching file scipy/signal/fir_filter_design.py patching file scipy/signal/ltisys.py patching file scipy/signal/signaltools.py patching file scipy/signal/spectral.py patching file scipy/signal/tests/test_peak_finding.py patching file scipy/signal/tests/test_wavelets.py patching file scipy/signal/waveforms.py patching file scipy/signal/windows.py patching file scipy/sparse/base.py patching file scipy/sparse/compressed.py patching file scipy/sparse/construct.py patching file scipy/sparse/coo.py patching file scipy/sparse/csr.py patching file scipy/sparse/dok.py patching file scipy/sparse/lil.py patching file scipy/sparse/linalg/eigen/lobpcg/lobpcg.py patching file scipy/sparse/linalg/isolve/_gcrotmk.py patching file scipy/sparse/linalg/isolve/lgmres.py patching file scipy/sparse/linalg/isolve/tests/test_lsqr.py patching file scipy/sparse/tests/test_base.py patching file scipy/spatial/distance.py patching file scipy/spatial/tests/test_distance.py patching file scipy/spatial/tests/test_qhull.py patching file scipy/special/_mptestutils.py patching file scipy/special/basic.py patching file scipy/special/tests/test_cdflib.py patching file scipy/special/tests/test_mpmath.py patching file scipy/special/tests/test_orthogonal.py patching file scipy/stats/_binned_statistic.py patching file scipy/stats/_distn_infrastructure.py patching file scipy/stats/kde.py patching file scipy/stats/morestats.py patching file scipy/stats/mstats_basic.py patching file scipy/stats/stats.py patching file scipy/stats/tests/test_binned_statistic.py patching file scipy/stats/tests/test_discrete_basic.py patching file scipy/stats/tests/test_stats.py patching file tools/authors.py + cat + exit 0 Executing(%build): /bin/sh -e /var/tmp/rpm-tmp.Wq7Qkw + umask 022 + cd /builddir/build/BUILD + cd scipy-1.0.0 + env 'CFLAGS=-O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection' 'FFLAGS=-O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -fPIC -cpp' 'LDFLAGS=-Wl,-z,relro -Wl,-z,now -specs=/usr/lib/rpm/redhat/redhat-hardened-ld -shared' OPENBLAS=/usr/lib64 FFTW=/usr/lib64 BLAS=/usr/lib64 LAPACK=/usr/lib64 /usr/bin/python2 setup.py config_fc --fcompiler=gnu95 --noarch build lapack_opt_info: lapack_mkl_info: customize UnixCCompiler libraries mkl_rt not found in ['/usr/local/lib64', '/usr/local/lib', '/usr/lib64', '/usr/lib', '/usr/lib/'] NOT AVAILABLE openblas_lapack_info: customize UnixCCompiler customize UnixCCompiler customize UnixCCompiler C compiler: gcc -pthread -fno-strict-aliasing -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -D_GNU_SOURCE -fPIC -fwrapv -DNDEBUG -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -D_GNU_SOURCE -fPIC -fwrapv -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -fPIC creating /tmp/tmpFJN0Fk/tmp creating /tmp/tmpFJN0Fk/tmp/tmpFJN0Fk compile options: '-c' gcc: /tmp/tmpFJN0Fk/source.c /tmp/tmpFJN0Fk/source.c: In function 'main': /tmp/tmpFJN0Fk/source.c:4:13: warning: implicit declaration of function 'zungqr_'; did you mean 'zungqr'? [-Wimplicit-function-declaration] zungqr_(); ^~~~~~~ zungqr gcc -pthread /tmp/tmpFJN0Fk/tmp/tmpFJN0Fk/source.o -L/usr/lib64 -lopenblasp -o /tmp/tmpFJN0Fk/a.out customize UnixCCompiler customize UnixCCompiler FOUND: libraries = ['openblasp', 'openblas'] library_dirs = ['/usr/lib64'] language = c define_macros = [('HAVE_CBLAS', None)] runtime_library_dirs = ['/usr/lib64'] FOUND: libraries = ['openblasp', 'openblas'] library_dirs = ['/usr/lib64'] language = c define_macros = [('HAVE_CBLAS', None)] runtime_library_dirs = ['/usr/lib64'] Running from scipy source directory. /usr/lib64/python2.7/site-packages/numpy/distutils/system_info.py:716: UserWarning: Specified path /usr/lib64/python2.7/site-packages/numpy/__init__.pyc/include/python2.7 is invalid. return self.get_paths(self.section, key) /usr/lib64/python2.7/site-packages/numpy/distutils/system_info.py:716: UserWarning: Specified path /usr/local/include/python2.7 is invalid. return self.get_paths(self.section, key) /usr/lib64/python2.7/site-packages/numpy/distutils/system_info.py:716: UserWarning: Specified path /usr/include/suitesparse/python2.7 is invalid. return self.get_paths(self.section, key) Splitting linalg.interpolative Fortran source files blas_opt_info: blas_mkl_info: customize UnixCCompiler libraries mkl_rt not found in ['/usr/local/lib64', '/usr/local/lib', '/usr/lib64', '/usr/lib', '/usr/lib/'] NOT AVAILABLE blis_info: customize UnixCCompiler libraries blis not found in ['/usr/local/lib64', '/usr/local/lib', '/usr/lib64', '/usr/lib', '/usr/lib/'] NOT AVAILABLE openblas_info: customize UnixCCompiler customize UnixCCompiler customize UnixCCompiler customize UnixCCompiler FOUND: libraries = ['openblasp', 'openblas'] library_dirs = ['/usr/lib64'] language = c define_macros = [('HAVE_CBLAS', None)] runtime_library_dirs = ['/usr/lib64'] FOUND: libraries = ['openblasp', 'openblas'] library_dirs = ['/usr/lib64'] language = c define_macros = [('HAVE_CBLAS', None)] runtime_library_dirs = ['/usr/lib64'] non-existing path in 'scipy/sparse': 'sparsetools/sparsetools_impl.h' non-existing path in 'scipy/sparse': 'sparsetools/bsr_impl.h' non-existing path in 'scipy/sparse': 'sparsetools/csc_impl.h' non-existing path in 'scipy/sparse': 'sparsetools/csr_impl.h' non-existing path in 'scipy/sparse': 'sparsetools/other_impl.h' running config_fc unifing config_fc, config, build_clib, build_ext, build commands --fcompiler options running build running config_cc unifing config_cc, config, build_clib, build_ext, build commands --compiler options running build_src build_src building py_modules sources creating build creating build/src.linux-ppc64le-2.7 creating build/src.linux-ppc64le-2.7/scipy building library "dfftpack" sources building library "fftpack" sources building library "mach" sources building library "quadpack" sources building library "lsoda" sources building library "vode" sources building library "dop" sources building library "fitpack" sources building library "fwrappers" sources building library "odrpack" sources building library "minpack" sources building library "rootfind" sources building library "superlu_src" sources building library "arpack_scipy" sources building library "sc_c_misc" sources building library "sc_cephes" sources building library "sc_mach" sources building library "sc_amos" sources building library "sc_cdf" sources building library "sc_specfun" sources building library "statlib" sources building extension "scipy.cluster._vq" sources building extension "scipy.cluster._hierarchy" sources building extension "scipy.cluster._optimal_leaf_ordering" sources building extension "scipy.fftpack._fftpack" sources creating build/src.linux-ppc64le-2.7/scipy/fftpack creating build/src.linux-ppc64le-2.7/scipy/fftpack/src conv_template:> build/src.linux-ppc64le-2.7/scipy/fftpack/src/dct.c conv_template:> build/src.linux-ppc64le-2.7/scipy/fftpack/src/dst.c f2py options: [] f2py: scipy/fftpack/fftpack.pyf Reading fortran codes... Reading file 'scipy/fftpack/fftpack.pyf' (format:free) Line #86 in scipy/fftpack/fftpack.pyf:" /* Single precision version */" crackline:2: No pattern for line Post-processing... Block: _fftpack Block: zfft Block: drfft Block: zrfft Block: zfftnd Block: destroy_zfft_cache Block: destroy_zfftnd_cache Block: destroy_drfft_cache Block: cfft Block: rfft Block: crfft Block: cfftnd Block: destroy_cfft_cache Block: destroy_cfftnd_cache Block: destroy_rfft_cache Block: ddct1 Block: ddct2 Block: ddct3 Block: dct1 Block: dct2 Block: dct3 Block: destroy_ddct2_cache Block: destroy_ddct1_cache Block: destroy_dct2_cache Block: destroy_dct1_cache Block: ddst1 Block: ddst2 Block: ddst3 Block: dst1 Block: dst2 Block: dst3 Block: destroy_ddst2_cache Block: destroy_ddst1_cache Block: destroy_dst2_cache Block: destroy_dst1_cache Post-processing (stage 2)... Building modules... Building module "_fftpack"... Constructing wrapper function "zfft"... getarrdims:warning: assumed shape array, using 0 instead of '*' y = zfft(x,[n,direction,normalize,overwrite_x]) Constructing wrapper function "drfft"... getarrdims:warning: assumed shape array, using 0 instead of '*' y = drfft(x,[n,direction,normalize,overwrite_x]) Constructing wrapper function "zrfft"... getarrdims:warning: assumed shape array, using 0 instead of '*' y = zrfft(x,[n,direction,normalize,overwrite_x]) Constructing wrapper function "zfftnd"... getarrdims:warning: assumed shape array, using 0 instead of '*' y = zfftnd(x,[s,direction,normalize,overwrite_x]) Constructing wrapper function "destroy_zfft_cache"... destroy_zfft_cache() Constructing wrapper function "destroy_zfftnd_cache"... destroy_zfftnd_cache() Constructing wrapper function "destroy_drfft_cache"... destroy_drfft_cache() Constructing wrapper function "cfft"... getarrdims:warning: assumed shape array, using 0 instead of '*' y = cfft(x,[n,direction,normalize,overwrite_x]) Constructing wrapper function "rfft"... getarrdims:warning: assumed shape array, using 0 instead of '*' y = rfft(x,[n,direction,normalize,overwrite_x]) Constructing wrapper function "crfft"... getarrdims:warning: assumed shape array, using 0 instead of '*' y = crfft(x,[n,direction,normalize,overwrite_x]) Constructing wrapper function "cfftnd"... getarrdims:warning: assumed shape array, using 0 instead of '*' y = cfftnd(x,[s,direction,normalize,overwrite_x]) Constructing wrapper function "destroy_cfft_cache"... destroy_cfft_cache() Constructing wrapper function "destroy_cfftnd_cache"... destroy_cfftnd_cache() Constructing wrapper function "destroy_rfft_cache"... destroy_rfft_cache() Constructing wrapper function "ddct1"... getarrdims:warning: assumed shape array, using 0 instead of '*' y = ddct1(x,[n,normalize,overwrite_x]) Constructing wrapper function "ddct2"... getarrdims:warning: assumed shape array, using 0 instead of '*' y = ddct2(x,[n,normalize,overwrite_x]) Constructing wrapper function "ddct3"... getarrdims:warning: assumed shape array, using 0 instead of '*' y = ddct3(x,[n,normalize,overwrite_x]) Constructing wrapper function "dct1"... getarrdims:warning: assumed shape array, using 0 instead of '*' y = dct1(x,[n,normalize,overwrite_x]) Constructing wrapper function "dct2"... getarrdims:warning: assumed shape array, using 0 instead of '*' y = dct2(x,[n,normalize,overwrite_x]) Constructing wrapper function "dct3"... getarrdims:warning: assumed shape array, using 0 instead of '*' y = dct3(x,[n,normalize,overwrite_x]) Constructing wrapper function "destroy_ddct2_cache"... destroy_ddct2_cache() Constructing wrapper function "destroy_ddct1_cache"... destroy_ddct1_cache() Constructing wrapper function "destroy_dct2_cache"... destroy_dct2_cache() Constructing wrapper function "destroy_dct1_cache"... destroy_dct1_cache() Constructing wrapper function "ddst1"... getarrdims:warning: assumed shape array, using 0 instead of '*' y = ddst1(x,[n,normalize,overwrite_x]) Constructing wrapper function "ddst2"... getarrdims:warning: assumed shape array, using 0 instead of '*' y = ddst2(x,[n,normalize,overwrite_x]) Constructing wrapper function "ddst3"... getarrdims:warning: assumed shape array, using 0 instead of '*' y = ddst3(x,[n,normalize,overwrite_x]) Constructing wrapper function "dst1"... getarrdims:warning: assumed shape array, using 0 instead of '*' y = dst1(x,[n,normalize,overwrite_x]) Constructing wrapper function "dst2"... getarrdims:warning: assumed shape array, using 0 instead of '*' y = dst2(x,[n,normalize,overwrite_x]) Constructing wrapper function "dst3"... getarrdims:warning: assumed shape array, using 0 instead of '*' y = dst3(x,[n,normalize,overwrite_x]) Constructing wrapper function "destroy_ddst2_cache"... destroy_ddst2_cache() Constructing wrapper function "destroy_ddst1_cache"... destroy_ddst1_cache() Constructing wrapper function "destroy_dst2_cache"... destroy_dst2_cache() Constructing wrapper function "destroy_dst1_cache"... destroy_dst1_cache() Wrote C/API module "_fftpack" to file "build/src.linux-ppc64le-2.7/scipy/fftpack/_fftpackmodule.c" adding 'build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/fftpack/fortranobject.c' to sources. adding 'build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/fftpack' to include_dirs. creating build/src.linux-ppc64le-2.7/build creating build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7 creating build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy creating build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/fftpack copying /usr/lib64/python2.7/site-packages/numpy/f2py/src/fortranobject.c -> build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/fftpack copying /usr/lib64/python2.7/site-packages/numpy/f2py/src/fortranobject.h -> build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/fftpack building extension "scipy.fftpack.convolve" sources f2py options: [] f2py: scipy/fftpack/convolve.pyf Reading fortran codes... Reading file 'scipy/fftpack/convolve.pyf' (format:free) Post-processing... Block: convolve__user__routines Block: kernel_func Block: convolve Block: init_convolution_kernel In: scipy/fftpack/convolve.pyf:convolve:unknown_interface:init_convolution_kernel get_useparameters: no module convolve__user__routines info used by init_convolution_kernel Block: destroy_convolve_cache Block: convolve Block: convolve_z Post-processing (stage 2)... Building modules... Constructing call-back function "cb_kernel_func_in_convolve__user__routines" def kernel_func(k): return kernel_func Building module "convolve"... Constructing wrapper function "init_convolution_kernel"... omega = init_convolution_kernel(n,kernel_func,[d,zero_nyquist,kernel_func_extra_args]) Constructing wrapper function "destroy_convolve_cache"... destroy_convolve_cache() Constructing wrapper function "convolve"... y = convolve(x,omega,[swap_real_imag,overwrite_x]) Constructing wrapper function "convolve_z"... y = convolve_z(x,omega_real,omega_imag,[overwrite_x]) Wrote C/API module "convolve" to file "build/src.linux-ppc64le-2.7/scipy/fftpack/convolvemodule.c" adding 'build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/fftpack/fortranobject.c' to sources. adding 'build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/fftpack' to include_dirs. building extension "scipy.integrate._quadpack" sources building extension "scipy.integrate._odepack" sources building extension "scipy.integrate.vode" sources creating build/src.linux-ppc64le-2.7/scipy/integrate f2py options: [] f2py: scipy/integrate/vode.pyf Reading fortran codes... Reading file 'scipy/integrate/vode.pyf' (format:free) Post-processing... Block: dvode__user__routines Block: dvode_user_interface Block: f Block: jac Block: zvode__user__routines Block: zvode_user_interface Block: f Block: jac Block: vode Block: dvode In: scipy/integrate/vode.pyf:vode:unknown_interface:dvode get_useparameters: no module dvode__user__routines info used by dvode Block: zvode In: scipy/integrate/vode.pyf:vode:unknown_interface:zvode get_useparameters: no module zvode__user__routines info used by zvode Post-processing (stage 2)... Building modules... Constructing call-back function "cb_f_in_dvode__user__routines" def f(t,y): return ydot Constructing call-back function "cb_jac_in_dvode__user__routines" def jac(t,y): return jac Constructing call-back function "cb_f_in_zvode__user__routines" def f(t,y): return ydot Constructing call-back function "cb_jac_in_zvode__user__routines" def jac(t,y): return jac Building module "vode"... Constructing wrapper function "dvode"... warning: callstatement is defined without callprotoargument getarrdims:warning: assumed shape array, using 0 instead of '*' getarrdims:warning: assumed shape array, using 0 instead of '*' y,t,istate = dvode(f,jac,y,t,tout,rtol,atol,itask,istate,rwork,iwork,mf,[f_extra_args,jac_extra_args,overwrite_y]) Constructing wrapper function "zvode"... warning: callstatement is defined without callprotoargument getarrdims:warning: assumed shape array, using 0 instead of '*' getarrdims:warning: assumed shape array, using 0 instead of '*' y,t,istate = zvode(f,jac,y,t,tout,rtol,atol,itask,istate,zwork,rwork,iwork,mf,[f_extra_args,jac_extra_args,overwrite_y]) Wrote C/API module "vode" to file "build/src.linux-ppc64le-2.7/scipy/integrate/vodemodule.c" adding 'build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/integrate/fortranobject.c' to sources. adding 'build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/integrate' to include_dirs. creating build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/integrate copying /usr/lib64/python2.7/site-packages/numpy/f2py/src/fortranobject.c -> build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/integrate copying /usr/lib64/python2.7/site-packages/numpy/f2py/src/fortranobject.h -> build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/integrate building extension "scipy.integrate.lsoda" sources f2py options: [] f2py: scipy/integrate/lsoda.pyf Reading fortran codes... Reading file 'scipy/integrate/lsoda.pyf' (format:free) Post-processing... Block: lsoda__user__routines Block: lsoda_user_interface Block: f Block: jac Block: lsoda Block: lsoda In: scipy/integrate/lsoda.pyf:lsoda:unknown_interface:lsoda get_useparameters: no module lsoda__user__routines info used by lsoda Post-processing (stage 2)... Building modules... Constructing call-back function "cb_f_in_lsoda__user__routines" def f(t,y): return ydot Constructing call-back function "cb_jac_in_lsoda__user__routines" def jac(t,y): return jac Building module "lsoda"... Constructing wrapper function "lsoda"... warning: callstatement is defined without callprotoargument getarrdims:warning: assumed shape array, using 0 instead of '*' getarrdims:warning: assumed shape array, using 0 instead of '*' y,t,istate = lsoda(f,y,t,tout,rtol,atol,itask,istate,rwork,iwork,jac,jt,[f_extra_args,overwrite_y,jac_extra_args]) Wrote C/API module "lsoda" to file "build/src.linux-ppc64le-2.7/scipy/integrate/lsodamodule.c" adding 'build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/integrate/fortranobject.c' to sources. adding 'build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/integrate' to include_dirs. building extension "scipy.integrate._dop" sources f2py options: [] f2py: scipy/integrate/dop.pyf Reading fortran codes... Reading file 'scipy/integrate/dop.pyf' (format:free) Post-processing... Block: __user__routines Block: fcn Block: solout Block: _dop Block: dopri5 In: scipy/integrate/dop.pyf:_dop:unknown_interface:dopri5 get_useparameters: no module __user__routines info used by dopri5 Block: dop853 In: scipy/integrate/dop.pyf:_dop:unknown_interface:dop853 get_useparameters: no module __user__routines info used by dop853 Post-processing (stage 2)... Building modules... Constructing call-back function "cb_fcn_in___user__routines" def fcn(x,y): return f Constructing call-back function "cb_solout_in___user__routines" def solout(nr,xold,x,y,con,icomp,[nd]): return irtn Building module "_dop"... Constructing wrapper function "dopri5"... getarrdims:warning: assumed shape array, using 0 instead of '*' getarrdims:warning: assumed shape array, using 0 instead of '*' getarrdims:warning: assumed shape array, using 0 instead of '*' getarrdims:warning: assumed shape array, using 0 instead of '*' x,y,iwork,idid = dopri5(fcn,x,y,xend,rtol,atol,solout,iout,work,iwork,[fcn_extra_args,overwrite_y,solout_extra_args]) Constructing wrapper function "dop853"... getarrdims:warning: assumed shape array, using 0 instead of '*' getarrdims:warning: assumed shape array, using 0 instead of '*' getarrdims:warning: assumed shape array, using 0 instead of '*' getarrdims:warning: assumed shape array, using 0 instead of '*' x,y,iwork,idid = dop853(fcn,x,y,xend,rtol,atol,solout,iout,work,iwork,[fcn_extra_args,overwrite_y,solout_extra_args]) Wrote C/API module "_dop" to file "build/src.linux-ppc64le-2.7/scipy/integrate/_dopmodule.c" adding 'build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/integrate/fortranobject.c' to sources. adding 'build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/integrate' to include_dirs. building extension "scipy.integrate._test_multivariate" sources building extension "scipy.integrate._test_odeint_banded" sources f2py options: [] f2py:> build/src.linux-ppc64le-2.7/scipy/integrate/_test_odeint_bandedmodule.c Reading fortran codes... Reading file 'scipy/integrate/tests/banded5x5.f' (format:fix,strict) Post-processing... Block: _test_odeint_banded Block: jacobian Block: getbands Block: banded5x5 Block: banded5x5_jac Block: banded5x5_bjac Block: banded5x5_solve Post-processing (stage 2)... Building modules... Building module "_test_odeint_banded"... Constructing wrapper function "getbands"... jac = getbands() Constructing wrapper function "banded5x5"... banded5x5(t,y,f,[n]) Constructing wrapper function "banded5x5_jac"... banded5x5_jac(t,y,ml,mu,jac,[n,nrowpd]) Constructing wrapper function "banded5x5_bjac"... banded5x5_bjac(t,y,ml,mu,bjac,[n,nrowpd]) Constructing wrapper function "banded5x5_solve"... nst,nfe,nje = banded5x5_solve(y,nsteps,dt,jt) Constructing COMMON block support for "jac"... bands Wrote C/API module "_test_odeint_banded" to file "build/src.linux-ppc64le-2.7/scipy/integrate/_test_odeint_bandedmodule.c" Fortran 77 wrappers are saved to "build/src.linux-ppc64le-2.7/scipy/integrate/_test_odeint_banded-f2pywrappers.f" adding 'build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/integrate/fortranobject.c' to sources. adding 'build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/integrate' to include_dirs. adding 'build/src.linux-ppc64le-2.7/scipy/integrate/_test_odeint_banded-f2pywrappers.f' to sources. building extension "scipy.interpolate.interpnd" sources building extension "scipy.interpolate._ppoly" sources building extension "scipy.interpolate._bspl" sources building extension "scipy.interpolate._fitpack" sources building extension "scipy.interpolate.dfitpack" sources creating build/src.linux-ppc64le-2.7/scipy/interpolate creating build/src.linux-ppc64le-2.7/scipy/interpolate/src f2py options: [] f2py: scipy/interpolate/src/fitpack.pyf Reading fortran codes... Reading file 'scipy/interpolate/src/fitpack.pyf' (format:free) Post-processing... Block: dfitpack Block: fpchec Block: splev Block: splder Block: splint Block: sproot Block: spalde Block: curfit Block: percur Block: parcur Block: fpcurf0 Block: fpcurf1 Block: fpcurfm1 Block: bispev Block: parder Block: bispeu Block: pardeu Block: surfit_smth Block: surfit_lsq Block: spherfit_smth Block: spherfit_lsq Block: regrid_smth Block: regrid_smth_spher Block: dblint Post-processing (stage 2)... Building modules... Building module "dfitpack"... Constructing wrapper function "fpchec"... ier = fpchec(x,t,k) Constructing wrapper function "splev"... y = splev(t,c,k,x,[e]) Constructing wrapper function "splder"... y = splder(t,c,k,x,[nu,e]) Creating wrapper for Fortran function "splint"("splint")... Constructing wrapper function "splint"... splint = splint(t,c,k,a,b) Constructing wrapper function "sproot"... zero,m,ier = sproot(t,c,[mest]) Constructing wrapper function "spalde"... d,ier = spalde(t,c,k,x) Constructing wrapper function "curfit"... n,c,fp,ier = curfit(iopt,x,y,w,t,wrk,iwrk,[xb,xe,k,s]) Constructing wrapper function "percur"... n,c,fp,ier = percur(iopt,x,y,w,t,wrk,iwrk,[k,s]) Constructing wrapper function "parcur"... n,c,fp,ier = parcur(iopt,ipar,idim,u,x,w,ub,ue,t,wrk,iwrk,[k,s]) Constructing wrapper function "fpcurf0"... x,y,w,xb,xe,k,s,n,t,c,fp,fpint,nrdata,ier = fpcurf0(x,y,k,[w,xb,xe,s,nest]) Constructing wrapper function "fpcurf1"... x,y,w,xb,xe,k,s,n,t,c,fp,fpint,nrdata,ier = fpcurf1(x,y,w,xb,xe,k,s,n,t,c,fp,fpint,nrdata,ier,[overwrite_x,overwrite_y,overwrite_w,overwrite_t,overwrite_c,overwrite_fpint,overwrite_nrdata]) Constructing wrapper function "fpcurfm1"... x,y,w,xb,xe,k,s,n,t,c,fp,fpint,nrdata,ier = fpcurfm1(x,y,k,t,[w,xb,xe,overwrite_t]) Constructing wrapper function "bispev"... z,ier = bispev(tx,ty,c,kx,ky,x,y) Constructing wrapper function "parder"... z,ier = parder(tx,ty,c,kx,ky,nux,nuy,x,y) Constructing wrapper function "bispeu"... z,ier = bispeu(tx,ty,c,kx,ky,x,y) Constructing wrapper function "pardeu"... z,ier = pardeu(tx,ty,c,kx,ky,nux,nuy,x,y) Constructing wrapper function "surfit_smth"... nx,tx,ny,ty,c,fp,wrk1,ier = surfit_smth(x,y,z,[w,xb,xe,yb,ye,kx,ky,s,nxest,nyest,eps,lwrk2]) Constructing wrapper function "surfit_lsq"... tx,ty,c,fp,ier = surfit_lsq(x,y,z,tx,ty,[w,xb,xe,yb,ye,kx,ky,eps,lwrk2,overwrite_tx,overwrite_ty]) Constructing wrapper function "spherfit_smth"... nt,tt,np,tp,c,fp,ier = spherfit_smth(teta,phi,r,[w,s,eps]) Constructing wrapper function "spherfit_lsq"... tt,tp,c,fp,ier = spherfit_lsq(teta,phi,r,tt,tp,[w,eps,overwrite_tt,overwrite_tp]) Constructing wrapper function "regrid_smth"... nx,tx,ny,ty,c,fp,ier = regrid_smth(x,y,z,[xb,xe,yb,ye,kx,ky,s]) Constructing wrapper function "regrid_smth_spher"... nu,tu,nv,tv,c,fp,ier = regrid_smth_spher(iopt,ider,u,v,r,[r0,r1,s]) Creating wrapper for Fortran function "dblint"("dblint")... Constructing wrapper function "dblint"... dblint = dblint(tx,ty,c,kx,ky,xb,xe,yb,ye) Wrote C/API module "dfitpack" to file "build/src.linux-ppc64le-2.7/scipy/interpolate/src/dfitpackmodule.c" Fortran 77 wrappers are saved to "build/src.linux-ppc64le-2.7/scipy/interpolate/src/dfitpack-f2pywrappers.f" adding 'build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/interpolate/src/fortranobject.c' to sources. adding 'build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/interpolate/src' to include_dirs. creating build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/interpolate creating build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/interpolate/src copying /usr/lib64/python2.7/site-packages/numpy/f2py/src/fortranobject.c -> build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/interpolate/src copying /usr/lib64/python2.7/site-packages/numpy/f2py/src/fortranobject.h -> build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/interpolate/src adding 'build/src.linux-ppc64le-2.7/scipy/interpolate/src/dfitpack-f2pywrappers.f' to sources. building extension "scipy.interpolate._interpolate" sources building extension "scipy.io._test_fortran" sources creating build/src.linux-ppc64le-2.7/scipy/io f2py options: [] f2py: scipy/io/_test_fortran.pyf Reading fortran codes... Reading file 'scipy/io/_test_fortran.pyf' (format:free) Post-processing... Block: _test_fortran Block: read_unformatted_double Block: read_unformatted_int Block: read_unformatted_mixed Post-processing (stage 2)... Building modules... Building module "_test_fortran"... Constructing wrapper function "read_unformatted_double"... a = read_unformatted_double(m,n,k,filename) Constructing wrapper function "read_unformatted_int"... a = read_unformatted_int(m,n,k,filename) Constructing wrapper function "read_unformatted_mixed"... a,b = read_unformatted_mixed(m,n,k,filename) Wrote C/API module "_test_fortran" to file "build/src.linux-ppc64le-2.7/scipy/io/_test_fortranmodule.c" adding 'build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/io/fortranobject.c' to sources. adding 'build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/io' to include_dirs. creating build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/io copying /usr/lib64/python2.7/site-packages/numpy/f2py/src/fortranobject.c -> build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/io copying /usr/lib64/python2.7/site-packages/numpy/f2py/src/fortranobject.h -> build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/io building extension "scipy.io.matlab.streams" sources building extension "scipy.io.matlab.mio_utils" sources building extension "scipy.io.matlab.mio5_utils" sources building extension "scipy.linalg._fblas" sources creating build/src.linux-ppc64le-2.7/scipy/linalg from_template:> build/src.linux-ppc64le-2.7/scipy/linalg/fblas.pyf Including file scipy/linalg/fblas_l1.pyf.src Including file scipy/linalg/fblas_l2.pyf.src Including file scipy/linalg/fblas_l3.pyf.src Mismatch in number of replacements (base ) for <__l1=->. Ignoring. Mismatch in number of replacements (base ) for . Ignoring. creating build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/linalg f2py options: [] f2py: build/src.linux-ppc64le-2.7/scipy/linalg/fblas.pyf Reading fortran codes... Reading file 'build/src.linux-ppc64le-2.7/scipy/linalg/fblas.pyf' (format:free) Post-processing... Block: _fblas Block: srotg Block: drotg Block: crotg Block: zrotg Block: srotmg Block: drotmg Block: srot Block: drot Block: csrot Block: zdrot Block: srotm Block: drotm Block: sswap Block: dswap Block: cswap Block: zswap Block: sscal Block: dscal Block: cscal Block: zscal Block: csscal Block: zdscal Block: scopy Block: dcopy Block: ccopy Block: zcopy Block: saxpy Block: daxpy Block: caxpy Block: zaxpy Block: sdot Block: ddot Block: cdotu Block: zdotu Block: cdotc Block: zdotc Block: snrm2 Block: scnrm2 Block: dnrm2 Block: dznrm2 Block: sasum Block: scasum Block: dasum Block: dzasum Block: isamax Block: idamax Block: icamax Block: izamax Block: sgemv Block: dgemv Block: cgemv Block: zgemv Block: sgbmv Block: dgbmv Block: cgbmv Block: zgbmv Block: ssbmv Block: dsbmv Block: chbmv Block: zhbmv Block: sspmv Block: dspmv Block: cspmv Block: zspmv Block: chpmv Block: zhpmv Block: ssymv Block: dsymv Block: chemv Block: zhemv Block: sger Block: dger Block: cgeru Block: zgeru Block: cgerc Block: zgerc Block: ssyr Block: dsyr Block: csyr Block: zsyr Block: cher Block: zher Block: ssyr2 Block: dsyr2 Block: cher2 Block: zher2 Block: sspr Block: dspr Block: cspr Block: zspr Block: chpr Block: zhpr Block: sspr2 Block: dspr2 Block: chpr2 Block: zhpr2 Block: stbsv Block: dtbsv Block: ctbsv Block: ztbsv Block: stpsv Block: dtpsv Block: ctpsv Block: ztpsv Block: strmv Block: dtrmv Block: ctrmv Block: ztrmv Block: strsv Block: dtrsv Block: ctrsv Block: ztrsv Block: stbmv Block: dtbmv Block: ctbmv Block: ztbmv Block: stpmv Block: dtpmv Block: ctpmv Block: ztpmv Block: sgemm Block: dgemm Block: cgemm Block: zgemm Block: ssymm Block: dsymm Block: csymm Block: zsymm Block: chemm Block: zhemm Block: ssyrk Block: dsyrk Block: csyrk Block: zsyrk Block: cherk Block: zherk Block: ssyr2k Block: dsyr2k Block: csyr2k Block: zsyr2k Block: cher2k Block: zher2k Block: strmm Block: dtrmm Block: ctrmm Block: ztrmm Block: strsm Block: dtrsm Block: ctrsm Block: ztrsm Post-processing (stage 2)... Building modules... Building module "_fblas"... Constructing wrapper function "srotg"... c,s = srotg(a,b) Constructing wrapper function "drotg"... c,s = drotg(a,b) Constructing wrapper function "crotg"... c,s = crotg(a,b) Constructing wrapper function "zrotg"... c,s = zrotg(a,b) Constructing wrapper function "srotmg"... param = srotmg(d1,d2,x1,y1) Constructing wrapper function "drotmg"... param = drotmg(d1,d2,x1,y1) Constructing wrapper function "srot"... getarrdims:warning: assumed shape array, using 0 instead of '*' getarrdims:warning: assumed shape array, using 0 instead of '*' x,y = srot(x,y,c,s,[n,offx,incx,offy,incy,overwrite_x,overwrite_y]) Constructing wrapper function "drot"... getarrdims:warning: assumed shape array, using 0 instead of '*' getarrdims:warning: assumed shape array, using 0 instead of '*' x,y = drot(x,y,c,s,[n,offx,incx,offy,incy,overwrite_x,overwrite_y]) Constructing wrapper function "csrot"... getarrdims:warning: assumed shape array, using 0 instead of '*' getarrdims:warning: assumed shape array, using 0 instead of '*' x,y = csrot(x,y,c,s,[n,offx,incx,offy,incy,overwrite_x,overwrite_y]) Constructing wrapper function "zdrot"... getarrdims:warning: assumed shape array, using 0 instead of '*' getarrdims:warning: assumed shape array, using 0 instead of '*' x,y = zdrot(x,y,c,s,[n,offx,incx,offy,incy,overwrite_x,overwrite_y]) Constructing wrapper function "srotm"... getarrdims:warning: assumed shape array, using 0 instead of '*' getarrdims:warning: assumed shape array, using 0 instead of '*' x,y = srotm(x,y,param,[n,offx,incx,offy,incy,overwrite_x,overwrite_y]) Constructing wrapper function "drotm"... getarrdims:warning: assumed shape array, using 0 instead of '*' getarrdims:warning: assumed shape array, using 0 instead of '*' x,y = drotm(x,y,param,[n,offx,incx,offy,incy,overwrite_x,overwrite_y]) Constructing wrapper function "sswap"... getarrdims:warning: assumed shape array, using 0 instead of '*' getarrdims:warning: assumed shape array, using 0 instead of '*' x,y = sswap(x,y,[n,offx,incx,offy,incy]) Constructing wrapper function "dswap"... getarrdims:warning: assumed shape array, using 0 instead of '*' getarrdims:warning: assumed shape array, using 0 instead of '*' x,y = dswap(x,y,[n,offx,incx,offy,incy]) Constructing wrapper function "cswap"... getarrdims:warning: assumed shape array, using 0 instead of '*' getarrdims:warning: assumed shape array, using 0 instead of '*' x,y = cswap(x,y,[n,offx,incx,offy,incy]) Constructing wrapper function "zswap"... getarrdims:warning: assumed shape array, using 0 instead of '*' getarrdims:warning: assumed shape array, using 0 instead of '*' x,y = zswap(x,y,[n,offx,incx,offy,incy]) Constructing wrapper function "sscal"... getarrdims:warning: assumed shape array, using 0 instead of '*' x = sscal(a,x,[n,offx,incx]) Constructing wrapper function "dscal"... getarrdims:warning: assumed shape array, using 0 instead of '*' x = dscal(a,x,[n,offx,incx]) Constructing wrapper function "cscal"... getarrdims:warning: assumed shape array, using 0 instead of '*' x = cscal(a,x,[n,offx,incx]) Constructing wrapper function "zscal"... getarrdims:warning: assumed shape array, using 0 instead of '*' x = zscal(a,x,[n,offx,incx]) Constructing wrapper function "csscal"... getarrdims:warning: assumed shape array, using 0 instead of '*' x = csscal(a,x,[n,offx,incx,overwrite_x]) Constructing wrapper function "zdscal"... getarrdims:warning: assumed shape array, using 0 instead of '*' x = zdscal(a,x,[n,offx,incx,overwrite_x]) Constructing wrapper function "scopy"... getarrdims:warning: assumed shape array, using 0 instead of '*' getarrdims:warning: assumed shape array, using 0 instead of '*' y = scopy(x,y,[n,offx,incx,offy,incy]) Constructing wrapper function "dcopy"... getarrdims:warning: assumed shape array, using 0 instead of '*' getarrdims:warning: assumed shape array, using 0 instead of '*' y = dcopy(x,y,[n,offx,incx,offy,incy]) Constructing wrapper function "ccopy"... getarrdims:warning: assumed shape array, using 0 instead of '*' getarrdims:warning: assumed shape array, using 0 instead of '*' y = ccopy(x,y,[n,offx,incx,offy,incy]) Constructing wrapper function "zcopy"... getarrdims:warning: assumed shape array, using 0 instead of '*' getarrdims:warning: assumed shape array, using 0 instead of '*' y = zcopy(x,y,[n,offx,incx,offy,incy]) Constructing wrapper function "saxpy"... getarrdims:warning: assumed shape array, using 0 instead of '*' getarrdims:warning: assumed shape array, using 0 instead of '*' z = saxpy(x,y,[n,a,offx,incx,offy,incy]) Constructing wrapper function "daxpy"... getarrdims:warning: assumed shape array, using 0 instead of '*' getarrdims:warning: assumed shape array, using 0 instead of '*' z = daxpy(x,y,[n,a,offx,incx,offy,incy]) Constructing wrapper function "caxpy"... getarrdims:warning: assumed shape array, using 0 instead of '*' getarrdims:warning: assumed shape array, using 0 instead of '*' z = caxpy(x,y,[n,a,offx,incx,offy,incy]) Constructing wrapper function "zaxpy"... getarrdims:warning: assumed shape array, using 0 instead of '*' getarrdims:warning: assumed shape array, using 0 instead of '*' z = zaxpy(x,y,[n,a,offx,incx,offy,incy]) Creating wrapper for Fortran function "sdot"("wsdot")... Constructing wrapper function "sdot"... getarrdims:warning: assumed shape array, using 0 instead of '*' getarrdims:warning: assumed shape array, using 0 instead of '*' xy = sdot(x,y,[n,offx,incx,offy,incy]) Creating wrapper for Fortran function "ddot"("ddot")... Constructing wrapper function "ddot"... getarrdims:warning: assumed shape array, using 0 instead of '*' getarrdims:warning: assumed shape array, using 0 instead of '*' xy = ddot(x,y,[n,offx,incx,offy,incy]) Creating wrapper for Fortran function "cdotu"("wcdotu")... Constructing wrapper function "cdotu"... getarrdims:warning: assumed shape array, using 0 instead of '*' getarrdims:warning: assumed shape array, using 0 instead of '*' xy = cdotu(x,y,[n,offx,incx,offy,incy]) Creating wrapper for Fortran function "zdotu"("wzdotu")... Constructing wrapper function "zdotu"... getarrdims:warning: assumed shape array, using 0 instead of '*' getarrdims:warning: assumed shape array, using 0 instead of '*' xy = zdotu(x,y,[n,offx,incx,offy,incy]) Creating wrapper for Fortran function "cdotc"("wcdotc")... Constructing wrapper function "cdotc"... getarrdims:warning: assumed shape array, using 0 instead of '*' getarrdims:warning: assumed shape array, using 0 instead of '*' xy = cdotc(x,y,[n,offx,incx,offy,incy]) Creating wrapper for Fortran function "zdotc"("wzdotc")... Constructing wrapper function "zdotc"... getarrdims:warning: assumed shape array, using 0 instead of '*' getarrdims:warning: assumed shape array, using 0 instead of '*' xy = zdotc(x,y,[n,offx,incx,offy,incy]) Creating wrapper for Fortran function "snrm2"("wsnrm2")... Constructing wrapper function "snrm2"... getarrdims:warning: assumed shape array, using 0 instead of '*' n2 = snrm2(x,[n,offx,incx]) Creating wrapper for Fortran function "scnrm2"("wscnrm2")... Constructing wrapper function "scnrm2"... getarrdims:warning: assumed shape array, using 0 instead of '*' n2 = scnrm2(x,[n,offx,incx]) Creating wrapper for Fortran function "dnrm2"("dnrm2")... Constructing wrapper function "dnrm2"... getarrdims:warning: assumed shape array, using 0 instead of '*' n2 = dnrm2(x,[n,offx,incx]) Creating wrapper for Fortran function "dznrm2"("dznrm2")... Constructing wrapper function "dznrm2"... getarrdims:warning: assumed shape array, using 0 instead of '*' n2 = dznrm2(x,[n,offx,incx]) Creating wrapper for Fortran function "sasum"("wsasum")... Constructing wrapper function "sasum"... getarrdims:warning: assumed shape array, using 0 instead of '*' s = sasum(x,[n,offx,incx]) Creating wrapper for Fortran function "scasum"("wscasum")... Constructing wrapper function "scasum"... getarrdims:warning: assumed shape array, using 0 instead of '*' s = scasum(x,[n,offx,incx]) Creating wrapper for Fortran function "dasum"("dasum")... Constructing wrapper function "dasum"... getarrdims:warning: assumed shape array, using 0 instead of '*' s = dasum(x,[n,offx,incx]) Creating wrapper for Fortran function "dzasum"("dzasum")... Constructing wrapper function "dzasum"... getarrdims:warning: assumed shape array, using 0 instead of '*' s = dzasum(x,[n,offx,incx]) Constructing wrapper function "isamax"... getarrdims:warning: assumed shape array, using 0 instead of '*' k = isamax(x,[n,offx,incx]) Constructing wrapper function "idamax"... getarrdims:warning: assumed shape array, using 0 instead of '*' k = idamax(x,[n,offx,incx]) Constructing wrapper function "icamax"... getarrdims:warning: assumed shape array, using 0 instead of '*' k = icamax(x,[n,offx,incx]) Constructing wrapper function "izamax"... getarrdims:warning: assumed shape array, using 0 instead of '*' k = izamax(x,[n,offx,incx]) Constructing wrapper function "sgemv"... getarrdims:warning: assumed shape array, using 0 instead of '*' y = sgemv(alpha,a,x,[beta,y,offx,incx,offy,incy,trans,overwrite_y]) Constructing wrapper function "dgemv"... getarrdims:warning: assumed shape array, using 0 instead of '*' y = dgemv(alpha,a,x,[beta,y,offx,incx,offy,incy,trans,overwrite_y]) Constructing wrapper function "cgemv"... getarrdims:warning: assumed shape array, using 0 instead of '*' y = cgemv(alpha,a,x,[beta,y,offx,incx,offy,incy,trans,overwrite_y]) Constructing wrapper function "zgemv"... getarrdims:warning: assumed shape array, using 0 instead of '*' y = zgemv(alpha,a,x,[beta,y,offx,incx,offy,incy,trans,overwrite_y]) Constructing wrapper function "sgbmv"... getarrdims:warning: assumed shape array, using 0 instead of '*' yout = sgbmv(m,n,kl,ku,alpha,a,x,[incx,offx,beta,y,incy,offy,trans,overwrite_y]) Constructing wrapper function "dgbmv"... getarrdims:warning: assumed shape array, using 0 instead of '*' yout = dgbmv(m,n,kl,ku,alpha,a,x,[incx,offx,beta,y,incy,offy,trans,overwrite_y]) Constructing wrapper function "cgbmv"... getarrdims:warning: assumed shape array, using 0 instead of '*' yout = cgbmv(m,n,kl,ku,alpha,a,x,[incx,offx,beta,y,incy,offy,trans,overwrite_y]) Constructing wrapper function "zgbmv"... getarrdims:warning: assumed shape array, using 0 instead of '*' yout = zgbmv(m,n,kl,ku,alpha,a,x,[incx,offx,beta,y,incy,offy,trans,overwrite_y]) Constructing wrapper function "ssbmv"... getarrdims:warning: assumed shape array, using 0 instead of '*' yout = ssbmv(k,alpha,a,x,[incx,offx,beta,y,incy,offy,lower,overwrite_y]) Constructing wrapper function "dsbmv"... getarrdims:warning: assumed shape array, using 0 instead of '*' yout = dsbmv(k,alpha,a,x,[incx,offx,beta,y,incy,offy,lower,overwrite_y]) Constructing wrapper function "chbmv"... getarrdims:warning: assumed shape array, using 0 instead of '*' yout = chbmv(k,alpha,a,x,[incx,offx,beta,y,incy,offy,lower,overwrite_y]) Constructing wrapper function "zhbmv"... getarrdims:warning: assumed shape array, using 0 instead of '*' yout = zhbmv(k,alpha,a,x,[incx,offx,beta,y,incy,offy,lower,overwrite_y]) Constructing wrapper function "sspmv"... getarrdims:warning: assumed shape array, using 0 instead of '*' getarrdims:warning: assumed shape array, using 0 instead of '*' yout = sspmv(n,alpha,ap,x,[incx,offx,beta,y,incy,offy,lower,overwrite_y]) Constructing wrapper function "dspmv"... getarrdims:warning: assumed shape array, using 0 instead of '*' getarrdims:warning: assumed shape array, using 0 instead of '*' yout = dspmv(n,alpha,ap,x,[incx,offx,beta,y,incy,offy,lower,overwrite_y]) Constructing wrapper function "cspmv"... getarrdims:warning: assumed shape array, using 0 instead of '*' getarrdims:warning: assumed shape array, using 0 instead of '*' yout = cspmv(n,alpha,ap,x,[incx,offx,beta,y,incy,offy,lower,overwrite_y]) Constructing wrapper function "zspmv"... getarrdims:warning: assumed shape array, using 0 instead of '*' getarrdims:warning: assumed shape array, using 0 instead of '*' yout = zspmv(n,alpha,ap,x,[incx,offx,beta,y,incy,offy,lower,overwrite_y]) Constructing wrapper function "chpmv"... getarrdims:warning: assumed shape array, using 0 instead of '*' getarrdims:warning: assumed shape array, using 0 instead of '*' yout = chpmv(n,alpha,ap,x,[incx,offx,beta,y,incy,offy,lower,overwrite_y]) Constructing wrapper function "zhpmv"... getarrdims:warning: assumed shape array, using 0 instead of '*' getarrdims:warning: assumed shape array, using 0 instead of '*' yout = zhpmv(n,alpha,ap,x,[incx,offx,beta,y,incy,offy,lower,overwrite_y]) Constructing wrapper function "ssymv"... getarrdims:warning: assumed shape array, using 0 instead of '*' y = ssymv(alpha,a,x,[beta,y,offx,incx,offy,incy,lower,overwrite_y]) Constructing wrapper function "dsymv"... getarrdims:warning: assumed shape array, using 0 instead of '*' y = dsymv(alpha,a,x,[beta,y,offx,incx,offy,incy,lower,overwrite_y]) Constructing wrapper function "chemv"... getarrdims:warning: assumed shape array, using 0 instead of '*' y = chemv(alpha,a,x,[beta,y,offx,incx,offy,incy,lower,overwrite_y]) Constructing wrapper function "zhemv"... getarrdims:warning: assumed shape array, using 0 instead of '*' y = zhemv(alpha,a,x,[beta,y,offx,incx,offy,incy,lower,overwrite_y]) Constructing wrapper function "sger"... a = sger(alpha,x,y,[incx,incy,a,overwrite_x,overwrite_y,overwrite_a]) Constructing wrapper function "dger"... a = dger(alpha,x,y,[incx,incy,a,overwrite_x,overwrite_y,overwrite_a]) Constructing wrapper function "cgeru"... a = cgeru(alpha,x,y,[incx,incy,a,overwrite_x,overwrite_y,overwrite_a]) Constructing wrapper function "zgeru"... a = zgeru(alpha,x,y,[incx,incy,a,overwrite_x,overwrite_y,overwrite_a]) Constructing wrapper function "cgerc"... a = cgerc(alpha,x,y,[incx,incy,a,overwrite_x,overwrite_y,overwrite_a]) Constructing wrapper function "zgerc"... a = zgerc(alpha,x,y,[incx,incy,a,overwrite_x,overwrite_y,overwrite_a]) Constructing wrapper function "ssyr"... getarrdims:warning: assumed shape array, using 0 instead of '*' a = ssyr(alpha,x,[lower,incx,offx,n,a,overwrite_a]) Constructing wrapper function "dsyr"... getarrdims:warning: assumed shape array, using 0 instead of '*' a = dsyr(alpha,x,[lower,incx,offx,n,a,overwrite_a]) Constructing wrapper function "csyr"... getarrdims:warning: assumed shape array, using 0 instead of '*' a = csyr(alpha,x,[lower,incx,offx,n,a,overwrite_a]) Constructing wrapper function "zsyr"... getarrdims:warning: assumed shape array, using 0 instead of '*' a = zsyr(alpha,x,[lower,incx,offx,n,a,overwrite_a]) Constructing wrapper function "cher"... getarrdims:warning: assumed shape array, using 0 instead of '*' a = cher(alpha,x,[lower,incx,offx,n,a,overwrite_a]) Constructing wrapper function "zher"... getarrdims:warning: assumed shape array, using 0 instead of '*' a = zher(alpha,x,[lower,incx,offx,n,a,overwrite_a]) Constructing wrapper function "ssyr2"... getarrdims:warning: assumed shape array, using 0 instead of '*' getarrdims:warning: assumed shape array, using 0 instead of '*' a = ssyr2(alpha,x,y,[lower,incx,offx,incy,offy,n,a,overwrite_a]) Constructing wrapper function "dsyr2"... getarrdims:warning: assumed shape array, using 0 instead of '*' getarrdims:warning: assumed shape array, using 0 instead of '*' a = dsyr2(alpha,x,y,[lower,incx,offx,incy,offy,n,a,overwrite_a]) Constructing wrapper function "cher2"... getarrdims:warning: assumed shape array, using 0 instead of '*' getarrdims:warning: assumed shape array, using 0 instead of '*' a = cher2(alpha,x,y,[lower,incx,offx,incy,offy,n,a,overwrite_a]) Constructing wrapper function "zher2"... getarrdims:warning: assumed shape array, using 0 instead of '*' getarrdims:warning: assumed shape array, using 0 instead of '*' a = zher2(alpha,x,y,[lower,incx,offx,incy,offy,n,a,overwrite_a]) Constructing wrapper function "sspr"... getarrdims:warning: assumed shape array, using 0 instead of '*' getarrdims:warning: assumed shape array, using 0 instead of '*' apu = sspr(n,alpha,x,ap,[incx,offx,lower,overwrite_ap]) Constructing wrapper function "dspr"... getarrdims:warning: assumed shape array, using 0 instead of '*' getarrdims:warning: assumed shape array, using 0 instead of '*' apu = dspr(n,alpha,x,ap,[incx,offx,lower,overwrite_ap]) Constructing wrapper function "cspr"... getarrdims:warning: assumed shape array, using 0 instead of '*' getarrdims:warning: assumed shape array, using 0 instead of '*' apu = cspr(n,alpha,x,ap,[incx,offx,lower,overwrite_ap]) Constructing wrapper function "zspr"... getarrdims:warning: assumed shape array, using 0 instead of '*' getarrdims:warning: assumed shape array, using 0 instead of '*' apu = zspr(n,alpha,x,ap,[incx,offx,lower,overwrite_ap]) Constructing wrapper function "chpr"... getarrdims:warning: assumed shape array, using 0 instead of '*' getarrdims:warning: assumed shape array, using 0 instead of '*' apu = chpr(n,alpha,x,ap,[incx,offx,lower,overwrite_ap]) Constructing wrapper function "zhpr"... getarrdims:warning: assumed shape array, using 0 instead of '*' getarrdims:warning: assumed shape array, using 0 instead of '*' apu = zhpr(n,alpha,x,ap,[incx,offx,lower,overwrite_ap]) Constructing wrapper function "sspr2"... getarrdims:warning: assumed shape array, using 0 instead of '*' getarrdims:warning: assumed shape array, using 0 instead of '*' getarrdims:warning: assumed shape array, using 0 instead of '*' apu = sspr2(n,alpha,x,y,ap,[incx,offx,incy,offy,lower,overwrite_ap]) Constructing wrapper function "dspr2"... getarrdims:warning: assumed shape array, using 0 instead of '*' getarrdims:warning: assumed shape array, using 0 instead of '*' getarrdims:warning: assumed shape array, using 0 instead of '*' apu = dspr2(n,alpha,x,y,ap,[incx,offx,incy,offy,lower,overwrite_ap]) Constructing wrapper function "chpr2"... getarrdims:warning: assumed shape array, using 0 instead of '*' getarrdims:warning: assumed shape array, using 0 instead of '*' getarrdims:warning: assumed shape array, using 0 instead of '*' apu = chpr2(n,alpha,x,y,ap,[incx,offx,incy,offy,lower,overwrite_ap]) Constructing wrapper function "zhpr2"... getarrdims:warning: assumed shape array, using 0 instead of '*' getarrdims:warning: assumed shape array, using 0 instead of '*' getarrdims:warning: assumed shape array, using 0 instead of '*' apu = zhpr2(n,alpha,x,y,ap,[incx,offx,incy,offy,lower,overwrite_ap]) Constructing wrapper function "stbsv"... getarrdims:warning: assumed shape array, using 0 instead of '*' xout = stbsv(k,a,x,[incx,offx,lower,trans,diag,overwrite_x]) Constructing wrapper function "dtbsv"... getarrdims:warning: assumed shape array, using 0 instead of '*' xout = dtbsv(k,a,x,[incx,offx,lower,trans,diag,overwrite_x]) Constructing wrapper function "ctbsv"... getarrdims:warning: assumed shape array, using 0 instead of '*' xout = ctbsv(k,a,x,[incx,offx,lower,trans,diag,overwrite_x]) Constructing wrapper function "ztbsv"... getarrdims:warning: assumed shape array, using 0 instead of '*' xout = ztbsv(k,a,x,[incx,offx,lower,trans,diag,overwrite_x]) Constructing wrapper function "stpsv"... getarrdims:warning: assumed shape array, using 0 instead of '*' getarrdims:warning: assumed shape array, using 0 instead of '*' xout = stpsv(n,ap,x,[incx,offx,lower,trans,diag,overwrite_x]) Constructing wrapper function "dtpsv"... getarrdims:warning: assumed shape array, using 0 instead of '*' getarrdims:warning: assumed shape array, using 0 instead of '*' xout = dtpsv(n,ap,x,[incx,offx,lower,trans,diag,overwrite_x]) Constructing wrapper function "ctpsv"... getarrdims:warning: assumed shape array, using 0 instead of '*' getarrdims:warning: assumed shape array, using 0 instead of '*' xout = ctpsv(n,ap,x,[incx,offx,lower,trans,diag,overwrite_x]) Constructing wrapper function "ztpsv"... getarrdims:warning: assumed shape array, using 0 instead of '*' getarrdims:warning: assumed shape array, using 0 instead of '*' xout = ztpsv(n,ap,x,[incx,offx,lower,trans,diag,overwrite_x]) Constructing wrapper function "strmv"... getarrdims:warning: assumed shape array, using 0 instead of '*' x = strmv(a,x,[offx,incx,lower,trans,diag,overwrite_x]) Constructing wrapper function "dtrmv"... getarrdims:warning: assumed shape array, using 0 instead of '*' x = dtrmv(a,x,[offx,incx,lower,trans,diag,overwrite_x]) Constructing wrapper function "ctrmv"... getarrdims:warning: assumed shape array, using 0 instead of '*' x = ctrmv(a,x,[offx,incx,lower,trans,diag,overwrite_x]) Constructing wrapper function "ztrmv"... getarrdims:warning: assumed shape array, using 0 instead of '*' x = ztrmv(a,x,[offx,incx,lower,trans,diag,overwrite_x]) Constructing wrapper function "strsv"... getarrdims:warning: assumed shape array, using 0 instead of '*' xout = strsv(a,x,[incx,offx,lower,trans,diag,overwrite_x]) Constructing wrapper function "dtrsv"... getarrdims:warning: assumed shape array, using 0 instead of '*' xout = dtrsv(a,x,[incx,offx,lower,trans,diag,overwrite_x]) Constructing wrapper function "ctrsv"... getarrdims:warning: assumed shape array, using 0 instead of '*' xout = ctrsv(a,x,[incx,offx,lower,trans,diag,overwrite_x]) Constructing wrapper function "ztrsv"... getarrdims:warning: assumed shape array, using 0 instead of '*' xout = ztrsv(a,x,[incx,offx,lower,trans,diag,overwrite_x]) Constructing wrapper function "stbmv"... getarrdims:warning: assumed shape array, using 0 instead of '*' xout = stbmv(k,a,x,[incx,offx,lower,trans,diag,overwrite_x]) Constructing wrapper function "dtbmv"... getarrdims:warning: assumed shape array, using 0 instead of '*' xout = dtbmv(k,a,x,[incx,offx,lower,trans,diag,overwrite_x]) Constructing wrapper function "ctbmv"... getarrdims:warning: assumed shape array, using 0 instead of '*' xout = ctbmv(k,a,x,[incx,offx,lower,trans,diag,overwrite_x]) Constructing wrapper function "ztbmv"... getarrdims:warning: assumed shape array, using 0 instead of '*' xout = ztbmv(k,a,x,[incx,offx,lower,trans,diag,overwrite_x]) Constructing wrapper function "stpmv"... getarrdims:warning: assumed shape array, using 0 instead of '*' getarrdims:warning: assumed shape array, using 0 instead of '*' xout = stpmv(n,ap,x,[incx,offx,lower,trans,diag,overwrite_x]) Constructing wrapper function "dtpmv"... getarrdims:warning: assumed shape array, using 0 instead of '*' getarrdims:warning: assumed shape array, using 0 instead of '*' xout = dtpmv(n,ap,x,[incx,offx,lower,trans,diag,overwrite_x]) Constructing wrapper function "ctpmv"... getarrdims:warning: assumed shape array, using 0 instead of '*' getarrdims:warning: assumed shape array, using 0 instead of '*' xout = ctpmv(n,ap,x,[incx,offx,lower,trans,diag,overwrite_x]) Constructing wrapper function "ztpmv"... getarrdims:warning: assumed shape array, using 0 instead of '*' getarrdims:warning: assumed shape array, using 0 instead of '*' xout = ztpmv(n,ap,x,[incx,offx,lower,trans,diag,overwrite_x]) Constructing wrapper function "sgemm"... c = sgemm(alpha,a,b,[beta,c,trans_a,trans_b,overwrite_c]) Constructing wrapper function "dgemm"... c = dgemm(alpha,a,b,[beta,c,trans_a,trans_b,overwrite_c]) Constructing wrapper function "cgemm"... c = cgemm(alpha,a,b,[beta,c,trans_a,trans_b,overwrite_c]) Constructing wrapper function "zgemm"... c = zgemm(alpha,a,b,[beta,c,trans_a,trans_b,overwrite_c]) Constructing wrapper function "ssymm"... c = ssymm(alpha,a,b,[beta,c,side,lower,overwrite_c]) Constructing wrapper function "dsymm"... c = dsymm(alpha,a,b,[beta,c,side,lower,overwrite_c]) Constructing wrapper function "csymm"... c = csymm(alpha,a,b,[beta,c,side,lower,overwrite_c]) Constructing wrapper function "zsymm"... c = zsymm(alpha,a,b,[beta,c,side,lower,overwrite_c]) Constructing wrapper function "chemm"... c = chemm(alpha,a,b,[beta,c,side,lower,overwrite_c]) Constructing wrapper function "zhemm"... c = zhemm(alpha,a,b,[beta,c,side,lower,overwrite_c]) Constructing wrapper function "ssyrk"... c = ssyrk(alpha,a,[beta,c,trans,lower,overwrite_c]) Constructing wrapper function "dsyrk"... c = dsyrk(alpha,a,[beta,c,trans,lower,overwrite_c]) Constructing wrapper function "csyrk"... c = csyrk(alpha,a,[beta,c,trans,lower,overwrite_c]) Constructing wrapper function "zsyrk"... c = zsyrk(alpha,a,[beta,c,trans,lower,overwrite_c]) Constructing wrapper function "cherk"... c = cherk(alpha,a,[beta,c,trans,lower,overwrite_c]) Constructing wrapper function "zherk"... c = zherk(alpha,a,[beta,c,trans,lower,overwrite_c]) Constructing wrapper function "ssyr2k"... c = ssyr2k(alpha,a,b,[beta,c,trans,lower,overwrite_c]) Constructing wrapper function "dsyr2k"... c = dsyr2k(alpha,a,b,[beta,c,trans,lower,overwrite_c]) Constructing wrapper function "csyr2k"... c = csyr2k(alpha,a,b,[beta,c,trans,lower,overwrite_c]) Constructing wrapper function "zsyr2k"... c = zsyr2k(alpha,a,b,[beta,c,trans,lower,overwrite_c]) Constructing wrapper function "cher2k"... c = cher2k(alpha,a,b,[beta,c,trans,lower,overwrite_c]) Constructing wrapper function "zher2k"... c = zher2k(alpha,a,b,[beta,c,trans,lower,overwrite_c]) Constructing wrapper function "strmm"... b = strmm(alpha,a,b,[side,lower,trans_a,diag,overwrite_b]) Constructing wrapper function "dtrmm"... b = dtrmm(alpha,a,b,[side,lower,trans_a,diag,overwrite_b]) Constructing wrapper function "ctrmm"... b = ctrmm(alpha,a,b,[side,lower,trans_a,diag,overwrite_b]) Constructing wrapper function "ztrmm"... b = ztrmm(alpha,a,b,[side,lower,trans_a,diag,overwrite_b]) Constructing wrapper function "strsm"... getarrdims:warning: assumed shape array, using 0 instead of '*' x = strsm(alpha,a,b,[side,lower,trans_a,diag,overwrite_b]) Constructing wrapper function "dtrsm"... getarrdims:warning: assumed shape array, using 0 instead of '*' x = dtrsm(alpha,a,b,[side,lower,trans_a,diag,overwrite_b]) Constructing wrapper function "ctrsm"... getarrdims:warning: assumed shape array, using 0 instead of '*' x = ctrsm(alpha,a,b,[side,lower,trans_a,diag,overwrite_b]) Constructing wrapper function "ztrsm"... getarrdims:warning: assumed shape array, using 0 instead of '*' x = ztrsm(alpha,a,b,[side,lower,trans_a,diag,overwrite_b]) Wrote C/API module "_fblas" to file "build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/linalg/_fblasmodule.c" Fortran 77 wrappers are saved to "build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/linalg/_fblas-f2pywrappers.f" adding 'build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/linalg/fortranobject.c' to sources. adding 'build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/linalg' to include_dirs. creating build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/build creating build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7 creating build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy creating build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/linalg copying /usr/lib64/python2.7/site-packages/numpy/f2py/src/fortranobject.c -> build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/linalg copying /usr/lib64/python2.7/site-packages/numpy/f2py/src/fortranobject.h -> build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/linalg adding 'build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/linalg/_fblas-f2pywrappers.f' to sources. building extension "scipy.linalg._flapack" sources from_template:> build/src.linux-ppc64le-2.7/scipy/linalg/flapack.pyf Including file scipy/linalg/flapack_user.pyf.src f2py options: [] f2py: build/src.linux-ppc64le-2.7/scipy/linalg/flapack.pyf Reading fortran codes... Reading file 'build/src.linux-ppc64le-2.7/scipy/linalg/flapack.pyf' (format:free) Post-processing... Block: _flapack Block: gees__user__routines Block: sselect Block: dselect Block: cselect Block: zselect Block: gges__user__routines Block: cselect Block: zselect Block: sselect Block: dselect Block: stgsen Block: dtgsen Block: ctgsen Block: ztgsen Block: sgges In: build/src.linux-ppc64le-2.7/scipy/linalg/flapack.pyf:_flapack:unknown_interface:sgges get_useparameters: no module gges__user__routines info used by sgges Block: dgges In: build/src.linux-ppc64le-2.7/scipy/linalg/flapack.pyf:_flapack:unknown_interface:dgges get_useparameters: no module gges__user__routines info used by dgges Block: cgges In: build/src.linux-ppc64le-2.7/scipy/linalg/flapack.pyf:_flapack:unknown_interface:cgges get_useparameters: no module gges__user__routines info used by cgges Block: zgges In: build/src.linux-ppc64le-2.7/scipy/linalg/flapack.pyf:_flapack:unknown_interface:zgges get_useparameters: no module gges__user__routines info used by zgges Block: spbtrf Block: dpbtrf Block: cpbtrf Block: zpbtrf Block: spbtrs Block: dpbtrs Block: cpbtrs Block: zpbtrs Block: strtrs Block: dtrtrs Block: ctrtrs Block: ztrtrs Block: spbsv Block: dpbsv Block: cpbsv Block: zpbsv Block: sptsv Block: dptsv Block: cptsv Block: zptsv Block: sgebal Block: dgebal Block: cgebal Block: zgebal Block: sgehrd Block: dgehrd Block: cgehrd Block: zgehrd Block: sgehrd_lwork Block: dgehrd_lwork Block: cgehrd_lwork Block: zgehrd_lwork Block: sorghr Block: dorghr Block: sorghr_lwork Block: dorghr_lwork Block: cunghr Block: zunghr Block: cunghr_lwork Block: zunghr_lwork Block: sgbsv Block: dgbsv Block: cgbsv Block: zgbsv Block: sgtsv Block: dgtsv Block: cgtsv Block: zgtsv Block: sgesv Block: dgesv Block: cgesv Block: zgesv Block: sgesvx Block: dgesvx Block: cgesvx Block: zgesvx Block: sgecon Block: dgecon Block: cgecon Block: zgecon Block: ssytf2 Block: dsytf2 Block: csytf2 Block: zsytf2 Block: ssytrf Block: dsytrf Block: csytrf Block: zsytrf Block: ssytrf_lwork Block: dsytrf_lwork Block: csytrf_lwork Block: zsytrf_lwork Block: ssysv Block: dsysv Block: csysv Block: zsysv Block: ssysv_lwork Block: dsysv_lwork Block: csysv_lwork Block: zsysv_lwork Block: ssysvx Block: dsysvx Block: csysvx Block: zsysvx Block: ssysvx_lwork Block: dsysvx_lwork Block: csysvx_lwork Block: zsysvx_lwork Block: ssycon Block: dsycon Block: csycon Block: zsycon Block: checon Block: zhecon Block: chetrf Block: zhetrf Block: chetrf_lwork Block: zhetrf_lwork Block: chesv Block: zhesv Block: chesv_lwork Block: zhesv_lwork Block: chesvx Block: zhesvx Block: chesvx_lwork Block: zhesvx_lwork Block: sgetrf Block: dgetrf Block: cgetrf Block: zgetrf Block: ssytrd Block: dsytrd Block: ssytrd_lwork Block: dsytrd_lwork Block: chetrd Block: zhetrd Block: chetrd_lwork Block: zhetrd_lwork Block: sgetrs Block: dgetrs Block: cgetrs Block: zgetrs Block: sgetri Block: dgetri Block: cgetri Block: zgetri Block: sgetri_lwork Block: dgetri_lwork Block: cgetri_lwork Block: zgetri_lwork Block: sgesdd Block: dgesdd Block: sgesdd_lwork Block: dgesdd_lwork Block: cgesdd Block: zgesdd Block: cgesdd_lwork Block: zgesdd_lwork Block: sgesvd Block: dgesvd Block: sgesvd_lwork Block: dgesvd_lwork Block: cgesvd Block: zgesvd Block: cgesvd_lwork Block: zgesvd_lwork Block: sgels Block: dgels Block: sgels_lwork Block: dgels_lwork Block: cgels Block: zgels Block: cgels_lwork Block: zgels_lwork Block: sgelss Block: dgelss Block: sgelss_lwork Block: dgelss_lwork Block: cgelss Block: zgelss Block: slasd4 Block: dlasd4 Block: cgelss_lwork Block: zgelss_lwork Block: sgelsy Block: dgelsy Block: sgelsy_lwork Block: dgelsy_lwork Block: cgelsy Block: zgelsy Block: cgelsy_lwork Block: zgelsy_lwork Block: sgelsd Block: dgelsd Block: sgelsd_lwork Block: dgelsd_lwork Block: cgelsd Block: zgelsd Block: cgelsd_lwork Block: zgelsd_lwork Block: sgeqp3 Block: dgeqp3 Block: cgeqp3 Block: zgeqp3 Block: sgeqrf Block: dgeqrf Block: cgeqrf Block: zgeqrf Block: sgerqf Block: dgerqf Block: cgerqf Block: zgerqf Block: sorgqr Block: dorgqr Block: cungqr Block: zungqr Block: sormqr Block: dormqr Block: cunmqr Block: zunmqr Block: sorgrq Block: dorgrq Block: cungrq Block: zungrq Block: sgeev Block: dgeev Block: sgeev_lwork Block: dgeev_lwork Block: cgeev Block: zgeev Block: cgeev_lwork Block: zgeev_lwork Block: sgegv Block: dgegv Block: cgegv Block: zgegv Block: ssyev Block: dsyev Block: cheev Block: zheev Block: ssyevd Block: dsyevd Block: cheevd Block: zheevd Block: sposv Block: dposv Block: cposv Block: zposv Block: sposvx Block: dposvx Block: cposvx Block: zposvx Block: spocon Block: dpocon Block: cpocon Block: zpocon Block: spotrf Block: dpotrf Block: cpotrf Block: zpotrf Block: spotrs Block: dpotrs Block: cpotrs Block: zpotrs Block: spotri Block: dpotri Block: cpotri Block: zpotri Block: slauum Block: dlauum Block: clauum Block: zlauum Block: strtri Block: dtrtri Block: ctrtri Block: ztrtri Block: strsyl Block: dtrsyl Block: ctrsyl Block: ztrsyl Block: slaswp Block: dlaswp Block: claswp Block: zlaswp Block: cgees In: build/src.linux-ppc64le-2.7/scipy/linalg/flapack.pyf:_flapack:unknown_interface:cgees get_useparameters: no module gees__user__routines info used by cgees Block: zgees In: build/src.linux-ppc64le-2.7/scipy/linalg/flapack.pyf:_flapack:unknown_interface:zgees get_useparameters: no module gees__user__routines info used by zgees Block: sgees In: build/src.linux-ppc64le-2.7/scipy/linalg/flapack.pyf:_flapack:unknown_interface:sgees get_useparameters: no module gees__user__routines info used by sgees Block: dgees In: build/src.linux-ppc64le-2.7/scipy/linalg/flapack.pyf:_flapack:unknown_interface:dgees get_useparameters: no module gees__user__routines info used by dgees Block: sggev Block: dggev Block: cggev Block: zggev Block: ssbev Block: dsbev Block: ssbevd Block: dsbevd Block: ssbevx Block: dsbevx Block: sstebz Block: dstebz Block: ssterf Block: dsterf Block: sstein Block: dstein Block: sstemr Block: dstemr Block: sstemr_lwork Block: dstemr_lwork Block: sstev Block: dstev Block: chbevd Block: zhbevd Block: chbevx Block: zhbevx Block: dlamch Block: slamch Block: sgbtrf Block: dgbtrf Block: cgbtrf Block: zgbtrf Block: sgbtrs Block: dgbtrs Block: cgbtrs Block: zgbtrs Block: ssyevr Block: dsyevr Block: cheevr Block: zheevr Block: ssygv Block: dsygv Block: chegv Block: zhegv Block: ssygvd Block: dsygvd Block: chegvd Block: zhegvd Block: ssygvx Block: dsygvx Block: chegvx Block: zhegvx Block: sgglse Block: dgglse Block: cgglse Block: zgglse Block: sgglse_lwork Block: dgglse_lwork Block: cgglse_lwork Block: zgglse_lwork Block: slange Block: dlange Block: clange Block: zlange Block: slarfg Block: dlarfg Block: clarfg Block: zlarfg Block: slarf Block: dlarf Block: clarf Block: zlarf Block: slartg Block: dlartg Block: clartg Block: zlartg Block: crot Block: zrot Block: ilaver Post-processing (stage 2)... Building modules... Constructing call-back function "cb_sselect_in_gees__user__routines" def sselect(arg1,arg2): return sselect Constructing call-back function "cb_dselect_in_gees__user__routines" def dselect(arg1,arg2): return dselect Constructing call-back function "cb_cselect_in_gees__user__routines" def cselect(arg): return cselect Constructing call-back function "cb_zselect_in_gees__user__routines" def zselect(arg): return zselect Constructing call-back function "cb_cselect_in_gges__user__routines" def cselect(alpha,beta): return cselect Constructing call-back function "cb_zselect_in_gges__user__routines" def zselect(alpha,beta): return zselect Constructing call-back function "cb_sselect_in_gges__user__routines" def sselect(alphar,alphai,beta): return sselect Constructing call-back function "cb_dselect_in_gges__user__routines" def dselect(alphar,alphai,beta): return dselect Building module "_flapack"... Constructing wrapper function "stgsen"... a,b,alphar,alphai,beta,q,z,m,pl,pr,dif,work,iwork,info = stgsen(select,a,b,q,z,[lwork,liwork,overwrite_a,overwrite_b,overwrite_q,overwrite_z]) Constructing wrapper function "dtgsen"... a,b,alphar,alphai,beta,q,z,m,pl,pr,dif,work,iwork,info = dtgsen(select,a,b,q,z,[lwork,liwork,overwrite_a,overwrite_b,overwrite_q,overwrite_z]) Constructing wrapper function "ctgsen"... a,b,alpha,beta,q,z,m,pl,pr,dif,work,iwork,info = ctgsen(select,a,b,q,z,[lwork,liwork,overwrite_a,overwrite_b,overwrite_q,overwrite_z]) Constructing wrapper function "ztgsen"... a,b,alpha,beta,q,z,m,pl,pr,dif,work,iwork,info = ztgsen(select,a,b,q,z,[lwork,liwork,overwrite_a,overwrite_b,overwrite_q,overwrite_z]) Constructing wrapper function "sgges"... a,b,sdim,alphar,alphai,beta,vsl,vsr,work,info = sgges(sselect,a,b,[jobvsl,jobvsr,sort_t,ldvsl,ldvsr,lwork,sselect_extra_args,overwrite_a,overwrite_b]) Constructing wrapper function "dgges"... a,b,sdim,alphar,alphai,beta,vsl,vsr,work,info = dgges(dselect,a,b,[jobvsl,jobvsr,sort_t,ldvsl,ldvsr,lwork,dselect_extra_args,overwrite_a,overwrite_b]) Constructing wrapper function "cgges"... a,b,sdim,alpha,beta,vsl,vsr,work,info = cgges(cselect,a,b,[jobvsl,jobvsr,sort_t,ldvsl,ldvsr,lwork,cselect_extra_args,overwrite_a,overwrite_b]) Constructing wrapper function "zgges"... a,b,sdim,alpha,beta,vsl,vsr,work,info = zgges(zselect,a,b,[jobvsl,jobvsr,sort_t,ldvsl,ldvsr,lwork,zselect_extra_args,overwrite_a,overwrite_b]) Constructing wrapper function "spbtrf"... c,info = spbtrf(ab,[lower,ldab,overwrite_ab]) Constructing wrapper function "dpbtrf"... c,info = dpbtrf(ab,[lower,ldab,overwrite_ab]) Constructing wrapper function "cpbtrf"... c,info = cpbtrf(ab,[lower,ldab,overwrite_ab]) Constructing wrapper function "zpbtrf"... c,info = zpbtrf(ab,[lower,ldab,overwrite_ab]) Constructing wrapper function "spbtrs"... x,info = spbtrs(ab,b,[lower,ldab,overwrite_b]) Constructing wrapper function "dpbtrs"... x,info = dpbtrs(ab,b,[lower,ldab,overwrite_b]) Constructing wrapper function "cpbtrs"... x,info = cpbtrs(ab,b,[lower,ldab,overwrite_b]) Constructing wrapper function "zpbtrs"... x,info = zpbtrs(ab,b,[lower,ldab,overwrite_b]) Constructing wrapper function "strtrs"... x,info = strtrs(a,b,[lower,trans,unitdiag,lda,overwrite_b]) Constructing wrapper function "dtrtrs"... x,info = dtrtrs(a,b,[lower,trans,unitdiag,lda,overwrite_b]) Constructing wrapper function "ctrtrs"... x,info = ctrtrs(a,b,[lower,trans,unitdiag,lda,overwrite_b]) Constructing wrapper function "ztrtrs"... x,info = ztrtrs(a,b,[lower,trans,unitdiag,lda,overwrite_b]) Constructing wrapper function "spbsv"... c,x,info = spbsv(ab,b,[lower,ldab,overwrite_ab,overwrite_b]) Constructing wrapper function "dpbsv"... c,x,info = dpbsv(ab,b,[lower,ldab,overwrite_ab,overwrite_b]) Constructing wrapper function "cpbsv"... c,x,info = cpbsv(ab,b,[lower,ldab,overwrite_ab,overwrite_b]) Constructing wrapper function "zpbsv"... c,x,info = zpbsv(ab,b,[lower,ldab,overwrite_ab,overwrite_b]) Constructing wrapper function "sptsv"... d,du,x,info = sptsv(d,e,b,[overwrite_d,overwrite_e,overwrite_b]) Constructing wrapper function "dptsv"... d,du,x,info = dptsv(d,e,b,[overwrite_d,overwrite_e,overwrite_b]) Constructing wrapper function "cptsv"... d,du,x,info = cptsv(d,e,b,[overwrite_d,overwrite_e,overwrite_b]) Constructing wrapper function "zptsv"... d,du,x,info = zptsv(d,e,b,[overwrite_d,overwrite_e,overwrite_b]) Constructing wrapper function "sgebal"... ba,lo,hi,pivscale,info = sgebal(a,[scale,permute,overwrite_a]) Constructing wrapper function "dgebal"... ba,lo,hi,pivscale,info = dgebal(a,[scale,permute,overwrite_a]) Constructing wrapper function "cgebal"... ba,lo,hi,pivscale,info = cgebal(a,[scale,permute,overwrite_a]) Constructing wrapper function "zgebal"... ba,lo,hi,pivscale,info = zgebal(a,[scale,permute,overwrite_a]) Constructing wrapper function "sgehrd"... ht,tau,info = sgehrd(a,[lo,hi,lwork,overwrite_a]) Constructing wrapper function "dgehrd"... ht,tau,info = dgehrd(a,[lo,hi,lwork,overwrite_a]) Constructing wrapper function "cgehrd"... ht,tau,info = cgehrd(a,[lo,hi,lwork,overwrite_a]) Constructing wrapper function "zgehrd"... ht,tau,info = zgehrd(a,[lo,hi,lwork,overwrite_a]) Constructing wrapper function "sgehrd_lwork"... work,info = sgehrd_lwork(n,[lo,hi]) Constructing wrapper function "dgehrd_lwork"... work,info = dgehrd_lwork(n,[lo,hi]) Constructing wrapper function "cgehrd_lwork"... work,info = cgehrd_lwork(n,[lo,hi]) Constructing wrapper function "zgehrd_lwork"... work,info = zgehrd_lwork(n,[lo,hi]) Constructing wrapper function "sorghr"... ht,info = sorghr(a,tau,[lo,hi,lwork,overwrite_a]) Constructing wrapper function "dorghr"... ht,info = dorghr(a,tau,[lo,hi,lwork,overwrite_a]) Constructing wrapper function "sorghr_lwork"... work,info = sorghr_lwork(n,[lo,hi]) Constructing wrapper function "dorghr_lwork"... work,info = dorghr_lwork(n,[lo,hi]) Constructing wrapper function "cunghr"... ht,info = cunghr(a,tau,[lo,hi,lwork,overwrite_a]) Constructing wrapper function "zunghr"... ht,info = zunghr(a,tau,[lo,hi,lwork,overwrite_a]) Constructing wrapper function "cunghr_lwork"... work,info = cunghr_lwork(n,[lo,hi]) Constructing wrapper function "zunghr_lwork"... work,info = zunghr_lwork(n,[lo,hi]) Constructing wrapper function "sgbsv"... lub,piv,x,info = sgbsv(kl,ku,ab,b,[overwrite_ab,overwrite_b]) Constructing wrapper function "dgbsv"... lub,piv,x,info = dgbsv(kl,ku,ab,b,[overwrite_ab,overwrite_b]) Constructing wrapper function "cgbsv"... lub,piv,x,info = cgbsv(kl,ku,ab,b,[overwrite_ab,overwrite_b]) Constructing wrapper function "zgbsv"... lub,piv,x,info = zgbsv(kl,ku,ab,b,[overwrite_ab,overwrite_b]) Constructing wrapper function "sgtsv"... du2,d,du,x,info = sgtsv(dl,d,du,b,[overwrite_dl,overwrite_d,overwrite_du,overwrite_b]) Constructing wrapper function "dgtsv"... du2,d,du,x,info = dgtsv(dl,d,du,b,[overwrite_dl,overwrite_d,overwrite_du,overwrite_b]) Constructing wrapper function "cgtsv"... du2,d,du,x,info = cgtsv(dl,d,du,b,[overwrite_dl,overwrite_d,overwrite_du,overwrite_b]) Constructing wrapper function "zgtsv"... du2,d,du,x,info = zgtsv(dl,d,du,b,[overwrite_dl,overwrite_d,overwrite_du,overwrite_b]) Constructing wrapper function "sgesv"... lu,piv,x,info = sgesv(a,b,[overwrite_a,overwrite_b]) Constructing wrapper function "dgesv"... lu,piv,x,info = dgesv(a,b,[overwrite_a,overwrite_b]) Constructing wrapper function "cgesv"... lu,piv,x,info = cgesv(a,b,[overwrite_a,overwrite_b]) Constructing wrapper function "zgesv"... lu,piv,x,info = zgesv(a,b,[overwrite_a,overwrite_b]) Constructing wrapper function "sgesvx"... as,lu,ipiv,equed,rs,cs,bs,x,rcond,ferr,berr,info = sgesvx(a,b,[fact,trans,af,ipiv,equed,r,c,overwrite_a,overwrite_b]) Constructing wrapper function "dgesvx"... as,lu,ipiv,equed,rs,cs,bs,x,rcond,ferr,berr,info = dgesvx(a,b,[fact,trans,af,ipiv,equed,r,c,overwrite_a,overwrite_b]) Constructing wrapper function "cgesvx"... as,lu,ipiv,equed,rs,cs,bs,x,rcond,ferr,berr,info = cgesvx(a,b,[fact,trans,af,ipiv,equed,r,c,overwrite_a,overwrite_b]) Constructing wrapper function "zgesvx"... as,lu,ipiv,equed,rs,cs,bs,x,rcond,ferr,berr,info = zgesvx(a,b,[fact,trans,af,ipiv,equed,r,c,overwrite_a,overwrite_b]) Constructing wrapper function "sgecon"... rcond,info = sgecon(a,anorm,[norm]) Constructing wrapper function "dgecon"... rcond,info = dgecon(a,anorm,[norm]) Constructing wrapper function "cgecon"... rcond,info = cgecon(a,anorm,[norm]) Constructing wrapper function "zgecon"... rcond,info = zgecon(a,anorm,[norm]) Constructing wrapper function "ssytf2"... ldu,ipiv,info = ssytf2(a,[lower,overwrite_a]) Constructing wrapper function "dsytf2"... ldu,ipiv,info = dsytf2(a,[lower,overwrite_a]) Constructing wrapper function "csytf2"... ldu,ipiv,info = csytf2(a,[lower,overwrite_a]) Constructing wrapper function "zsytf2"... ldu,ipiv,info = zsytf2(a,[lower,overwrite_a]) Constructing wrapper function "ssytrf"... ldu,ipiv,info = ssytrf(a,[lower,lwork,overwrite_a]) Constructing wrapper function "dsytrf"... ldu,ipiv,info = dsytrf(a,[lower,lwork,overwrite_a]) Constructing wrapper function "csytrf"... ldu,ipiv,info = csytrf(a,[lower,lwork,overwrite_a]) Constructing wrapper function "zsytrf"... ldu,ipiv,info = zsytrf(a,[lower,lwork,overwrite_a]) Constructing wrapper function "ssytrf_lwork"... work,info = ssytrf_lwork(n,[lower]) Constructing wrapper function "dsytrf_lwork"... work,info = dsytrf_lwork(n,[lower]) Constructing wrapper function "csytrf_lwork"... work,info = csytrf_lwork(n,[lower]) Constructing wrapper function "zsytrf_lwork"... work,info = zsytrf_lwork(n,[lower]) Constructing wrapper function "ssysv"... udut,ipiv,x,info = ssysv(a,b,[lwork,lower,overwrite_a,overwrite_b]) Constructing wrapper function "dsysv"... udut,ipiv,x,info = dsysv(a,b,[lwork,lower,overwrite_a,overwrite_b]) Constructing wrapper function "csysv"... udut,ipiv,x,info = csysv(a,b,[lwork,lower,overwrite_a,overwrite_b]) Constructing wrapper function "zsysv"... udut,ipiv,x,info = zsysv(a,b,[lwork,lower,overwrite_a,overwrite_b]) Constructing wrapper function "ssysv_lwork"... work,info = ssysv_lwork(n,[lower]) Constructing wrapper function "dsysv_lwork"... work,info = dsysv_lwork(n,[lower]) Constructing wrapper function "csysv_lwork"... work,info = csysv_lwork(n,[lower]) Constructing wrapper function "zsysv_lwork"... work,info = zsysv_lwork(n,[lower]) Constructing wrapper function "ssysvx"... a_s,udut,ipiv,b_s,x,rcond,ferr,berr,info = ssysvx(a,b,[af,ipiv,lwork,factored,lower,overwrite_a,overwrite_b]) Constructing wrapper function "dsysvx"... a_s,udut,ipiv,b_s,x,rcond,ferr,berr,info = dsysvx(a,b,[af,ipiv,lwork,factored,lower,overwrite_a,overwrite_b]) Constructing wrapper function "csysvx"... a_s,udut,ipiv,b_s,x,rcond,ferr,berr,info = csysvx(a,b,[af,ipiv,lwork,factored,lower,overwrite_a,overwrite_b]) Constructing wrapper function "zsysvx"... a_s,udut,ipiv,b_s,x,rcond,ferr,berr,info = zsysvx(a,b,[af,ipiv,lwork,factored,lower,overwrite_a,overwrite_b]) Constructing wrapper function "ssysvx_lwork"... work,info = ssysvx_lwork(n,[lower]) Constructing wrapper function "dsysvx_lwork"... work,info = dsysvx_lwork(n,[lower]) Constructing wrapper function "csysvx_lwork"... work,info = csysvx_lwork(n,[lower]) Constructing wrapper function "zsysvx_lwork"... work,info = zsysvx_lwork(n,[lower]) Constructing wrapper function "ssycon"... rcond,info = ssycon(a,ipiv,anorm,[lower]) Constructing wrapper function "dsycon"... rcond,info = dsycon(a,ipiv,anorm,[lower]) Constructing wrapper function "csycon"... rcond,info = csycon(a,ipiv,anorm,[lower]) Constructing wrapper function "zsycon"... rcond,info = zsycon(a,ipiv,anorm,[lower]) Constructing wrapper function "checon"... rcond,info = checon(a,ipiv,anorm,[lower]) Constructing wrapper function "zhecon"... rcond,info = zhecon(a,ipiv,anorm,[lower]) Constructing wrapper function "chetrf"... ldu,ipiv,info = chetrf(a,[lower,lwork,overwrite_a]) Constructing wrapper function "zhetrf"... ldu,ipiv,info = zhetrf(a,[lower,lwork,overwrite_a]) Constructing wrapper function "chetrf_lwork"... work,info = chetrf_lwork(n,[lower]) Constructing wrapper function "zhetrf_lwork"... work,info = zhetrf_lwork(n,[lower]) Constructing wrapper function "chesv"... uduh,ipiv,x,info = chesv(a,b,[lwork,lower,overwrite_a,overwrite_b]) Constructing wrapper function "zhesv"... uduh,ipiv,x,info = zhesv(a,b,[lwork,lower,overwrite_a,overwrite_b]) Constructing wrapper function "chesv_lwork"... work,info = chesv_lwork(n,[lower]) Constructing wrapper function "zhesv_lwork"... work,info = zhesv_lwork(n,[lower]) Constructing wrapper function "chesvx"... uduh,ipiv,x,rcond,ferr,berr,info = chesvx(a,b,[af,ipiv,lwork,factored,lower,overwrite_a,overwrite_b]) Constructing wrapper function "zhesvx"... uduh,ipiv,x,rcond,ferr,berr,info = zhesvx(a,b,[af,ipiv,lwork,factored,lower,overwrite_a,overwrite_b]) Constructing wrapper function "chesvx_lwork"... work,info = chesvx_lwork(n,[lower]) Constructing wrapper function "zhesvx_lwork"... work,info = zhesvx_lwork(n,[lower]) Constructing wrapper function "sgetrf"... lu,piv,info = sgetrf(a,[overwrite_a]) Constructing wrapper function "dgetrf"... lu,piv,info = dgetrf(a,[overwrite_a]) Constructing wrapper function "cgetrf"... lu,piv,info = cgetrf(a,[overwrite_a]) Constructing wrapper function "zgetrf"... lu,piv,info = zgetrf(a,[overwrite_a]) Constructing wrapper function "ssytrd"... c,d,e,tau,info = ssytrd(a,[lower,lwork,overwrite_a]) Constructing wrapper function "dsytrd"... c,d,e,tau,info = dsytrd(a,[lower,lwork,overwrite_a]) Constructing wrapper function "ssytrd_lwork"... work,info = ssytrd_lwork(n,[lower]) Constructing wrapper function "dsytrd_lwork"... work,info = dsytrd_lwork(n,[lower]) Constructing wrapper function "chetrd"... c,d,e,tau,info = chetrd(a,[lower,lwork,overwrite_a]) Constructing wrapper function "zhetrd"... c,d,e,tau,info = zhetrd(a,[lower,lwork,overwrite_a]) Constructing wrapper function "chetrd_lwork"... work,info = chetrd_lwork(n,[lower]) Constructing wrapper function "zhetrd_lwork"... work,info = zhetrd_lwork(n,[lower]) Constructing wrapper function "sgetrs"... x,info = sgetrs(lu,piv,b,[trans,overwrite_b]) Constructing wrapper function "dgetrs"... x,info = dgetrs(lu,piv,b,[trans,overwrite_b]) Constructing wrapper function "cgetrs"... x,info = cgetrs(lu,piv,b,[trans,overwrite_b]) Constructing wrapper function "zgetrs"... x,info = zgetrs(lu,piv,b,[trans,overwrite_b]) Constructing wrapper function "sgetri"... inv_a,info = sgetri(lu,piv,[lwork,overwrite_lu]) Constructing wrapper function "dgetri"... inv_a,info = dgetri(lu,piv,[lwork,overwrite_lu]) Constructing wrapper function "cgetri"... inv_a,info = cgetri(lu,piv,[lwork,overwrite_lu]) Constructing wrapper function "zgetri"... inv_a,info = zgetri(lu,piv,[lwork,overwrite_lu]) Constructing wrapper function "sgetri_lwork"... work,info = sgetri_lwork(n) Constructing wrapper function "dgetri_lwork"... work,info = dgetri_lwork(n) Constructing wrapper function "cgetri_lwork"... work,info = cgetri_lwork(n) Constructing wrapper function "zgetri_lwork"... work,info = zgetri_lwork(n) Constructing wrapper function "sgesdd"... u,s,vt,info = sgesdd(a,[compute_uv,full_matrices,lwork,overwrite_a]) Constructing wrapper function "dgesdd"... u,s,vt,info = dgesdd(a,[compute_uv,full_matrices,lwork,overwrite_a]) Constructing wrapper function "sgesdd_lwork"... work,info = sgesdd_lwork(m,n,[compute_uv,full_matrices]) Constructing wrapper function "dgesdd_lwork"... work,info = dgesdd_lwork(m,n,[compute_uv,full_matrices]) Constructing wrapper function "cgesdd"... u,s,vt,info = cgesdd(a,[compute_uv,full_matrices,lwork,overwrite_a]) Constructing wrapper function "zgesdd"... u,s,vt,info = zgesdd(a,[compute_uv,full_matrices,lwork,overwrite_a]) Constructing wrapper function "cgesdd_lwork"... work,info = cgesdd_lwork(m,n,[compute_uv,full_matrices]) Constructing wrapper function "zgesdd_lwork"... work,info = zgesdd_lwork(m,n,[compute_uv,full_matrices]) Constructing wrapper function "sgesvd"... u,s,vt,info = sgesvd(a,[compute_uv,full_matrices,lwork,overwrite_a]) Constructing wrapper function "dgesvd"... u,s,vt,info = dgesvd(a,[compute_uv,full_matrices,lwork,overwrite_a]) Constructing wrapper function "sgesvd_lwork"... work,info = sgesvd_lwork(m,n,[compute_uv,full_matrices]) Constructing wrapper function "dgesvd_lwork"... work,info = dgesvd_lwork(m,n,[compute_uv,full_matrices]) Constructing wrapper function "cgesvd"... u,s,vt,info = cgesvd(a,[compute_uv,full_matrices,lwork,overwrite_a]) Constructing wrapper function "zgesvd"... u,s,vt,info = zgesvd(a,[compute_uv,full_matrices,lwork,overwrite_a]) Constructing wrapper function "cgesvd_lwork"... work,info = cgesvd_lwork(m,n,[compute_uv,full_matrices]) Constructing wrapper function "zgesvd_lwork"... work,info = zgesvd_lwork(m,n,[compute_uv,full_matrices]) Constructing wrapper function "sgels"... lqr,x,info = sgels(a,b,[trans,lwork,overwrite_a,overwrite_b]) Constructing wrapper function "dgels"... lqr,x,info = dgels(a,b,[trans,lwork,overwrite_a,overwrite_b]) Constructing wrapper function "sgels_lwork"... work,info = sgels_lwork(m,n,nrhs,[trans]) Constructing wrapper function "dgels_lwork"... work,info = dgels_lwork(m,n,nrhs,[trans]) Constructing wrapper function "cgels"... lqr,x,info = cgels(a,b,[trans,lwork,overwrite_a,overwrite_b]) Constructing wrapper function "zgels"... lqr,x,info = zgels(a,b,[trans,lwork,overwrite_a,overwrite_b]) Constructing wrapper function "cgels_lwork"... work,info = cgels_lwork(m,n,nrhs,[trans]) Constructing wrapper function "zgels_lwork"... work,info = zgels_lwork(m,n,nrhs,[trans]) Constructing wrapper function "sgelss"... v,x,s,rank,work,info = sgelss(a,b,[cond,lwork,overwrite_a,overwrite_b]) Constructing wrapper function "dgelss"... v,x,s,rank,work,info = dgelss(a,b,[cond,lwork,overwrite_a,overwrite_b]) Constructing wrapper function "sgelss_lwork"... work,info = sgelss_lwork(m,n,nrhs,[cond,lwork]) Constructing wrapper function "dgelss_lwork"... work,info = dgelss_lwork(m,n,nrhs,[cond,lwork]) Constructing wrapper function "cgelss"... v,x,s,rank,work,info = cgelss(a,b,[cond,lwork,overwrite_a,overwrite_b]) Constructing wrapper function "zgelss"... v,x,s,rank,work,info = zgelss(a,b,[cond,lwork,overwrite_a,overwrite_b]) Constructing wrapper function "slasd4"... delta,sigma,work,info = slasd4(i,d,z,[rho]) Constructing wrapper function "dlasd4"... delta,sigma,work,info = dlasd4(i,d,z,[rho]) Constructing wrapper function "cgelss_lwork"... work,info = cgelss_lwork(m,n,nrhs,[cond,lwork]) Constructing wrapper function "zgelss_lwork"... work,info = zgelss_lwork(m,n,nrhs,[cond,lwork]) Constructing wrapper function "sgelsy"... v,x,j,rank,info = sgelsy(a,b,jptv,cond,lwork,[overwrite_a,overwrite_b]) Constructing wrapper function "dgelsy"... v,x,j,rank,info = dgelsy(a,b,jptv,cond,lwork,[overwrite_a,overwrite_b]) Constructing wrapper function "sgelsy_lwork"... work,info = sgelsy_lwork(m,n,nrhs,cond,[lwork]) Constructing wrapper function "dgelsy_lwork"... work,info = dgelsy_lwork(m,n,nrhs,cond,[lwork]) Constructing wrapper function "cgelsy"... v,x,j,rank,info = cgelsy(a,b,jptv,cond,lwork,[overwrite_a,overwrite_b]) Constructing wrapper function "zgelsy"... v,x,j,rank,info = zgelsy(a,b,jptv,cond,lwork,[overwrite_a,overwrite_b]) Constructing wrapper function "cgelsy_lwork"... work,info = cgelsy_lwork(m,n,nrhs,cond,[lwork]) Constructing wrapper function "zgelsy_lwork"... work,info = zgelsy_lwork(m,n,nrhs,cond,[lwork]) Constructing wrapper function "sgelsd"... x,s,rank,info = sgelsd(a,b,lwork,size_iwork,[cond,overwrite_a,overwrite_b]) Constructing wrapper function "dgelsd"... x,s,rank,info = dgelsd(a,b,lwork,size_iwork,[cond,overwrite_a,overwrite_b]) Constructing wrapper function "sgelsd_lwork"... work,iwork,info = sgelsd_lwork(m,n,nrhs,[cond,lwork]) Constructing wrapper function "dgelsd_lwork"... work,iwork,info = dgelsd_lwork(m,n,nrhs,[cond,lwork]) Constructing wrapper function "cgelsd"... x,s,rank,info = cgelsd(a,b,lwork,size_rwork,size_iwork,[cond,overwrite_a,overwrite_b]) Constructing wrapper function "zgelsd"... x,s,rank,info = zgelsd(a,b,lwork,size_rwork,size_iwork,[cond,overwrite_a,overwrite_b]) Constructing wrapper function "cgelsd_lwork"... work,rwork,iwork,info = cgelsd_lwork(m,n,nrhs,[cond,lwork]) Constructing wrapper function "zgelsd_lwork"... work,rwork,iwork,info = zgelsd_lwork(m,n,nrhs,[cond,lwork]) Constructing wrapper function "sgeqp3"... qr,jpvt,tau,work,info = sgeqp3(a,[lwork,overwrite_a]) Constructing wrapper function "dgeqp3"... qr,jpvt,tau,work,info = dgeqp3(a,[lwork,overwrite_a]) Constructing wrapper function "cgeqp3"... qr,jpvt,tau,work,info = cgeqp3(a,[lwork,overwrite_a]) Constructing wrapper function "zgeqp3"... qr,jpvt,tau,work,info = zgeqp3(a,[lwork,overwrite_a]) Constructing wrapper function "sgeqrf"... qr,tau,work,info = sgeqrf(a,[lwork,overwrite_a]) Constructing wrapper function "dgeqrf"... qr,tau,work,info = dgeqrf(a,[lwork,overwrite_a]) Constructing wrapper function "cgeqrf"... qr,tau,work,info = cgeqrf(a,[lwork,overwrite_a]) Constructing wrapper function "zgeqrf"... qr,tau,work,info = zgeqrf(a,[lwork,overwrite_a]) Constructing wrapper function "sgerqf"... qr,tau,work,info = sgerqf(a,[lwork,overwrite_a]) Constructing wrapper function "dgerqf"... qr,tau,work,info = dgerqf(a,[lwork,overwrite_a]) Constructing wrapper function "cgerqf"... qr,tau,work,info = cgerqf(a,[lwork,overwrite_a]) Constructing wrapper function "zgerqf"... qr,tau,work,info = zgerqf(a,[lwork,overwrite_a]) Constructing wrapper function "sorgqr"... q,work,info = sorgqr(a,tau,[lwork,overwrite_a]) Constructing wrapper function "dorgqr"... q,work,info = dorgqr(a,tau,[lwork,overwrite_a]) Constructing wrapper function "cungqr"... q,work,info = cungqr(a,tau,[lwork,overwrite_a]) Constructing wrapper function "zungqr"... q,work,info = zungqr(a,tau,[lwork,overwrite_a]) Constructing wrapper function "sormqr"... cq,work,info = sormqr(side,trans,a,tau,c,lwork,[overwrite_c]) Constructing wrapper function "dormqr"... cq,work,info = dormqr(side,trans,a,tau,c,lwork,[overwrite_c]) Constructing wrapper function "cunmqr"... cq,work,info = cunmqr(side,trans,a,tau,c,lwork,[overwrite_c]) Constructing wrapper function "zunmqr"... cq,work,info = zunmqr(side,trans,a,tau,c,lwork,[overwrite_c]) Constructing wrapper function "sorgrq"... q,work,info = sorgrq(a,tau,[lwork,overwrite_a]) Constructing wrapper function "dorgrq"... q,work,info = dorgrq(a,tau,[lwork,overwrite_a]) Constructing wrapper function "cungrq"... q,work,info = cungrq(a,tau,[lwork,overwrite_a]) Constructing wrapper function "zungrq"... q,work,info = zungrq(a,tau,[lwork,overwrite_a]) Constructing wrapper function "sgeev"... wr,wi,vl,vr,info = sgeev(a,[compute_vl,compute_vr,lwork,overwrite_a]) Constructing wrapper function "dgeev"... wr,wi,vl,vr,info = dgeev(a,[compute_vl,compute_vr,lwork,overwrite_a]) Constructing wrapper function "sgeev_lwork"... work,info = sgeev_lwork(n,[compute_vl,compute_vr]) Constructing wrapper function "dgeev_lwork"... work,info = dgeev_lwork(n,[compute_vl,compute_vr]) Constructing wrapper function "cgeev"... w,vl,vr,info = cgeev(a,[compute_vl,compute_vr,lwork,overwrite_a]) Constructing wrapper function "zgeev"... w,vl,vr,info = zgeev(a,[compute_vl,compute_vr,lwork,overwrite_a]) Constructing wrapper function "cgeev_lwork"... work,info = cgeev_lwork(n,[compute_vl,compute_vr]) Constructing wrapper function "zgeev_lwork"... work,info = zgeev_lwork(n,[compute_vl,compute_vr]) Constructing wrapper function "sgegv"... alphar,alphai,beta,vl,vr,info = sgegv(a,b,[compute_vl,compute_vr,lwork,overwrite_a,overwrite_b]) Constructing wrapper function "dgegv"... alphar,alphai,beta,vl,vr,info = dgegv(a,b,[compute_vl,compute_vr,lwork,overwrite_a,overwrite_b]) Constructing wrapper function "cgegv"... alpha,beta,vl,vr,info = cgegv(a,b,[compute_vl,compute_vr,lwork,overwrite_a,overwrite_b]) Constructing wrapper function "zgegv"... alpha,beta,vl,vr,info = zgegv(a,b,[compute_vl,compute_vr,lwork,overwrite_a,overwrite_b]) Constructing wrapper function "ssyev"... w,v,info = ssyev(a,[compute_v,lower,lwork,overwrite_a]) Constructing wrapper function "dsyev"... w,v,info = dsyev(a,[compute_v,lower,lwork,overwrite_a]) Constructing wrapper function "cheev"... w,v,info = cheev(a,[compute_v,lower,lwork,overwrite_a]) Constructing wrapper function "zheev"... w,v,info = zheev(a,[compute_v,lower,lwork,overwrite_a]) Constructing wrapper function "ssyevd"... w,v,info = ssyevd(a,[compute_v,lower,lwork,overwrite_a]) Constructing wrapper function "dsyevd"... w,v,info = dsyevd(a,[compute_v,lower,lwork,overwrite_a]) Constructing wrapper function "cheevd"... w,v,info = cheevd(a,[compute_v,lower,lwork,overwrite_a]) Constructing wrapper function "zheevd"... w,v,info = zheevd(a,[compute_v,lower,lwork,overwrite_a]) Constructing wrapper function "sposv"... c,x,info = sposv(a,b,[lower,overwrite_a,overwrite_b]) Constructing wrapper function "dposv"... c,x,info = dposv(a,b,[lower,overwrite_a,overwrite_b]) Constructing wrapper function "cposv"... c,x,info = cposv(a,b,[lower,overwrite_a,overwrite_b]) Constructing wrapper function "zposv"... c,x,info = zposv(a,b,[lower,overwrite_a,overwrite_b]) Constructing wrapper function "sposvx"... a_s,lu,equed,s,b_s,x,rcond,ferr,berr,info = sposvx(a,b,[fact,af,equed,s,lower,overwrite_a,overwrite_b]) Constructing wrapper function "dposvx"... a_s,lu,equed,s,b_s,x,rcond,ferr,berr,info = dposvx(a,b,[fact,af,equed,s,lower,overwrite_a,overwrite_b]) Constructing wrapper function "cposvx"... a_s,lu,equed,s,b_s,x,rcond,ferr,berr,info = cposvx(a,b,[fact,af,equed,s,lower,overwrite_a,overwrite_b]) Constructing wrapper function "zposvx"... a_s,lu,equed,s,b_s,x,rcond,ferr,berr,info = zposvx(a,b,[fact,af,equed,s,lower,overwrite_a,overwrite_b]) Constructing wrapper function "spocon"... rcond,info = spocon(a,anorm,[uplo]) Constructing wrapper function "dpocon"... rcond,info = dpocon(a,anorm,[uplo]) Constructing wrapper function "cpocon"... rcond,info = cpocon(a,anorm,[uplo]) Constructing wrapper function "zpocon"... rcond,info = zpocon(a,anorm,[uplo]) Constructing wrapper function "spotrf"... c,info = spotrf(a,[lower,clean,overwrite_a]) Constructing wrapper function "dpotrf"... c,info = dpotrf(a,[lower,clean,overwrite_a]) Constructing wrapper function "cpotrf"... c,info = cpotrf(a,[lower,clean,overwrite_a]) Constructing wrapper function "zpotrf"... c,info = zpotrf(a,[lower,clean,overwrite_a]) Constructing wrapper function "spotrs"... x,info = spotrs(c,b,[lower,overwrite_b]) Constructing wrapper function "dpotrs"... x,info = dpotrs(c,b,[lower,overwrite_b]) Constructing wrapper function "cpotrs"... x,info = cpotrs(c,b,[lower,overwrite_b]) Constructing wrapper function "zpotrs"... x,info = zpotrs(c,b,[lower,overwrite_b]) Constructing wrapper function "spotri"... inv_a,info = spotri(c,[lower,overwrite_c]) Constructing wrapper function "dpotri"... inv_a,info = dpotri(c,[lower,overwrite_c]) Constructing wrapper function "cpotri"... inv_a,info = cpotri(c,[lower,overwrite_c]) Constructing wrapper function "zpotri"... inv_a,info = zpotri(c,[lower,overwrite_c]) Constructing wrapper function "slauum"... a,info = slauum(c,[lower,overwrite_c]) Constructing wrapper function "dlauum"... a,info = dlauum(c,[lower,overwrite_c]) Constructing wrapper function "clauum"... a,info = clauum(c,[lower,overwrite_c]) Constructing wrapper function "zlauum"... a,info = zlauum(c,[lower,overwrite_c]) Constructing wrapper function "strtri"... inv_c,info = strtri(c,[lower,unitdiag,overwrite_c]) Constructing wrapper function "dtrtri"... inv_c,info = dtrtri(c,[lower,unitdiag,overwrite_c]) Constructing wrapper function "ctrtri"... inv_c,info = ctrtri(c,[lower,unitdiag,overwrite_c]) Constructing wrapper function "ztrtri"... inv_c,info = ztrtri(c,[lower,unitdiag,overwrite_c]) Constructing wrapper function "strsyl"... x,scale,info = strsyl(a,b,c,[trana,tranb,isgn,overwrite_c]) Constructing wrapper function "dtrsyl"... x,scale,info = dtrsyl(a,b,c,[trana,tranb,isgn,overwrite_c]) Constructing wrapper function "ctrsyl"... x,scale,info = ctrsyl(a,b,c,[trana,tranb,isgn,overwrite_c]) Constructing wrapper function "ztrsyl"... x,scale,info = ztrsyl(a,b,c,[trana,tranb,isgn,overwrite_c]) Constructing wrapper function "slaswp"... getarrdims:warning: assumed shape array, using 0 instead of '*' a = slaswp(a,piv,[k1,k2,off,inc,overwrite_a]) Constructing wrapper function "dlaswp"... getarrdims:warning: assumed shape array, using 0 instead of '*' a = dlaswp(a,piv,[k1,k2,off,inc,overwrite_a]) Constructing wrapper function "claswp"... getarrdims:warning: assumed shape array, using 0 instead of '*' a = claswp(a,piv,[k1,k2,off,inc,overwrite_a]) Constructing wrapper function "zlaswp"... getarrdims:warning: assumed shape array, using 0 instead of '*' a = zlaswp(a,piv,[k1,k2,off,inc,overwrite_a]) Constructing wrapper function "cgees"... t,sdim,w,vs,work,info = cgees(cselect,a,[compute_v,sort_t,lwork,cselect_extra_args,overwrite_a]) Constructing wrapper function "zgees"... t,sdim,w,vs,work,info = zgees(zselect,a,[compute_v,sort_t,lwork,zselect_extra_args,overwrite_a]) Constructing wrapper function "sgees"... t,sdim,wr,wi,vs,work,info = sgees(sselect,a,[compute_v,sort_t,lwork,sselect_extra_args,overwrite_a]) Constructing wrapper function "dgees"... t,sdim,wr,wi,vs,work,info = dgees(dselect,a,[compute_v,sort_t,lwork,dselect_extra_args,overwrite_a]) Constructing wrapper function "sggev"... alphar,alphai,beta,vl,vr,work,info = sggev(a,b,[compute_vl,compute_vr,lwork,overwrite_a,overwrite_b]) Constructing wrapper function "dggev"... alphar,alphai,beta,vl,vr,work,info = dggev(a,b,[compute_vl,compute_vr,lwork,overwrite_a,overwrite_b]) Constructing wrapper function "cggev"... alpha,beta,vl,vr,work,info = cggev(a,b,[compute_vl,compute_vr,lwork,overwrite_a,overwrite_b]) Constructing wrapper function "zggev"... alpha,beta,vl,vr,work,info = zggev(a,b,[compute_vl,compute_vr,lwork,overwrite_a,overwrite_b]) Constructing wrapper function "ssbev"... w,z,info = ssbev(ab,[compute_v,lower,ldab,overwrite_ab]) Constructing wrapper function "dsbev"... w,z,info = dsbev(ab,[compute_v,lower,ldab,overwrite_ab]) Constructing wrapper function "ssbevd"... w,z,info = ssbevd(ab,[compute_v,lower,ldab,liwork,overwrite_ab]) Constructing wrapper function "dsbevd"... w,z,info = dsbevd(ab,[compute_v,lower,ldab,liwork,overwrite_ab]) Constructing wrapper function "ssbevx"... w,z,m,ifail,info = ssbevx(ab,vl,vu,il,iu,[ldab,compute_v,range,lower,abstol,mmax,overwrite_ab]) Constructing wrapper function "dsbevx"... w,z,m,ifail,info = dsbevx(ab,vl,vu,il,iu,[ldab,compute_v,range,lower,abstol,mmax,overwrite_ab]) Constructing wrapper function "sstebz"... m,w,iblock,isplit,info = sstebz(d,e,range,vl,vu,il,iu,tol,order) Constructing wrapper function "dstebz"... m,w,iblock,isplit,info = dstebz(d,e,range,vl,vu,il,iu,tol,order) Constructing wrapper function "ssterf"... vals,info = ssterf(d,e,[overwrite_d,overwrite_e]) Constructing wrapper function "dsterf"... vals,info = dsterf(d,e,[overwrite_d,overwrite_e]) Constructing wrapper function "sstein"... z,info = sstein(d,e,w,iblock,isplit) Constructing wrapper function "dstein"... z,info = dstein(d,e,w,iblock,isplit) Constructing wrapper function "sstemr"... m,w,z,info = sstemr(d,e,range,vl,vu,il,iu,[compute_v,lwork,liwork,overwrite_d]) Constructing wrapper function "dstemr"... m,w,z,info = dstemr(d,e,range,vl,vu,il,iu,[compute_v,lwork,liwork,overwrite_d]) Constructing wrapper function "sstemr_lwork"... work,iwork,info = sstemr_lwork(d,e,range,vl,vu,il,iu,[compute_v,overwrite_d,overwrite_e]) Constructing wrapper function "dstemr_lwork"... work,iwork,info = dstemr_lwork(d,e,range,vl,vu,il,iu,[compute_v,overwrite_d,overwrite_e]) Constructing wrapper function "sstev"... vals,z,info = sstev(d,e,[compute_v,overwrite_d,overwrite_e]) Constructing wrapper function "dstev"... vals,z,info = dstev(d,e,[compute_v,overwrite_d,overwrite_e]) Constructing wrapper function "chbevd"... w,z,info = chbevd(ab,[compute_v,lower,ldab,lrwork,liwork,overwrite_ab]) Constructing wrapper function "zhbevd"... w,z,info = zhbevd(ab,[compute_v,lower,ldab,lrwork,liwork,overwrite_ab]) Constructing wrapper function "chbevx"... w,z,m,ifail,info = chbevx(ab,vl,vu,il,iu,[ldab,compute_v,range,lower,abstol,mmax,overwrite_ab]) Constructing wrapper function "zhbevx"... w,z,m,ifail,info = zhbevx(ab,vl,vu,il,iu,[ldab,compute_v,range,lower,abstol,mmax,overwrite_ab]) Creating wrapper for Fortran function "dlamch"("dlamch")... Constructing wrapper function "dlamch"... dlamch = dlamch(cmach) Creating wrapper for Fortran function "slamch"("wslamch")... Constructing wrapper function "slamch"... slamch = slamch(cmach) Constructing wrapper function "sgbtrf"... getarrdims:warning: assumed shape array, using 0 instead of '*' lu,ipiv,info = sgbtrf(ab,kl,ku,[m,n,ldab,overwrite_ab]) Constructing wrapper function "dgbtrf"... getarrdims:warning: assumed shape array, using 0 instead of '*' lu,ipiv,info = dgbtrf(ab,kl,ku,[m,n,ldab,overwrite_ab]) Constructing wrapper function "cgbtrf"... getarrdims:warning: assumed shape array, using 0 instead of '*' lu,ipiv,info = cgbtrf(ab,kl,ku,[m,n,ldab,overwrite_ab]) Constructing wrapper function "zgbtrf"... getarrdims:warning: assumed shape array, using 0 instead of '*' lu,ipiv,info = zgbtrf(ab,kl,ku,[m,n,ldab,overwrite_ab]) Constructing wrapper function "sgbtrs"... x,info = sgbtrs(ab,kl,ku,b,ipiv,[trans,n,ldab,ldb,overwrite_b]) Constructing wrapper function "dgbtrs"... x,info = dgbtrs(ab,kl,ku,b,ipiv,[trans,n,ldab,ldb,overwrite_b]) Constructing wrapper function "cgbtrs"... x,info = cgbtrs(ab,kl,ku,b,ipiv,[trans,n,ldab,ldb,overwrite_b]) Constructing wrapper function "zgbtrs"... x,info = zgbtrs(ab,kl,ku,b,ipiv,[trans,n,ldab,ldb,overwrite_b]) Constructing wrapper function "ssyevr"... w,z,info = ssyevr(a,[jobz,range,uplo,il,iu,lwork,overwrite_a]) Constructing wrapper function "dsyevr"... w,z,info = dsyevr(a,[jobz,range,uplo,il,iu,lwork,overwrite_a]) Constructing wrapper function "cheevr"... w,z,info = cheevr(a,[jobz,range,uplo,il,iu,lwork,overwrite_a]) Constructing wrapper function "zheevr"... w,z,info = zheevr(a,[jobz,range,uplo,il,iu,lwork,overwrite_a]) Constructing wrapper function "ssygv"... a,w,info = ssygv(a,b,[itype,jobz,uplo,overwrite_a,overwrite_b]) Constructing wrapper function "dsygv"... a,w,info = dsygv(a,b,[itype,jobz,uplo,overwrite_a,overwrite_b]) Constructing wrapper function "chegv"... a,w,info = chegv(a,b,[itype,jobz,uplo,overwrite_a,overwrite_b]) Constructing wrapper function "zhegv"... a,w,info = zhegv(a,b,[itype,jobz,uplo,overwrite_a,overwrite_b]) Constructing wrapper function "ssygvd"... a,w,info = ssygvd(a,b,[itype,jobz,uplo,lwork,overwrite_a,overwrite_b]) Constructing wrapper function "dsygvd"... a,w,info = dsygvd(a,b,[itype,jobz,uplo,lwork,overwrite_a,overwrite_b]) Constructing wrapper function "chegvd"... a,w,info = chegvd(a,b,[itype,jobz,uplo,lwork,overwrite_a,overwrite_b]) Constructing wrapper function "zhegvd"... a,w,info = zhegvd(a,b,[itype,jobz,uplo,lwork,overwrite_a,overwrite_b]) Constructing wrapper function "ssygvx"... w,z,ifail,info = ssygvx(a,b,iu,[itype,jobz,uplo,il,lwork,overwrite_a,overwrite_b]) Constructing wrapper function "dsygvx"... w,z,ifail,info = dsygvx(a,b,iu,[itype,jobz,uplo,il,lwork,overwrite_a,overwrite_b]) Constructing wrapper function "chegvx"... w,z,ifail,info = chegvx(a,b,iu,[itype,jobz,uplo,il,lwork,overwrite_a,overwrite_b]) Constructing wrapper function "zhegvx"... w,z,ifail,info = zhegvx(a,b,iu,[itype,jobz,uplo,il,lwork,overwrite_a,overwrite_b]) Constructing wrapper function "sgglse"... t,r,res,x,info = sgglse(a,b,c,d,[lwork,overwrite_a,overwrite_b,overwrite_c,overwrite_d]) Constructing wrapper function "dgglse"... t,r,res,x,info = dgglse(a,b,c,d,[lwork,overwrite_a,overwrite_b,overwrite_c,overwrite_d]) Constructing wrapper function "cgglse"... t,r,res,x,info = cgglse(a,b,c,d,[lwork,overwrite_a,overwrite_b,overwrite_c,overwrite_d]) Constructing wrapper function "zgglse"... t,r,res,x,info = zgglse(a,b,c,d,[lwork,overwrite_a,overwrite_b,overwrite_c,overwrite_d]) Constructing wrapper function "sgglse_lwork"... work,info = sgglse_lwork(m,n,p) Constructing wrapper function "dgglse_lwork"... work,info = dgglse_lwork(m,n,p) Constructing wrapper function "cgglse_lwork"... work,info = cgglse_lwork(m,n,p) Constructing wrapper function "zgglse_lwork"... work,info = zgglse_lwork(m,n,p) Creating wrapper for Fortran function "slange"("wslange")... Constructing wrapper function "slange"... n2 = slange(norm,a) Creating wrapper for Fortran function "dlange"("dlange")... Constructing wrapper function "dlange"... n2 = dlange(norm,a) Creating wrapper for Fortran function "clange"("wclange")... Constructing wrapper function "clange"... n2 = clange(norm,a) Creating wrapper for Fortran function "zlange"("zlange")... Constructing wrapper function "zlange"... n2 = zlange(norm,a) Constructing wrapper function "slarfg"... getarrdims:warning: assumed shape array, using 0 instead of '*' alpha,x,tau = slarfg(n,alpha,x,[incx,overwrite_x]) Constructing wrapper function "dlarfg"... getarrdims:warning: assumed shape array, using 0 instead of '*' alpha,x,tau = dlarfg(n,alpha,x,[incx,overwrite_x]) Constructing wrapper function "clarfg"... getarrdims:warning: assumed shape array, using 0 instead of '*' alpha,x,tau = clarfg(n,alpha,x,[incx,overwrite_x]) Constructing wrapper function "zlarfg"... getarrdims:warning: assumed shape array, using 0 instead of '*' alpha,x,tau = zlarfg(n,alpha,x,[incx,overwrite_x]) Constructing wrapper function "slarf"... getarrdims:warning: assumed shape array, using 0 instead of '*' getarrdims:warning: assumed shape array, using 0 instead of '*' c = slarf(v,tau,c,work,[side,incv,overwrite_c]) Constructing wrapper function "dlarf"... getarrdims:warning: assumed shape array, using 0 instead of '*' getarrdims:warning: assumed shape array, using 0 instead of '*' c = dlarf(v,tau,c,work,[side,incv,overwrite_c]) Constructing wrapper function "clarf"... getarrdims:warning: assumed shape array, using 0 instead of '*' getarrdims:warning: assumed shape array, using 0 instead of '*' c = clarf(v,tau,c,work,[side,incv,overwrite_c]) Constructing wrapper function "zlarf"... getarrdims:warning: assumed shape array, using 0 instead of '*' getarrdims:warning: assumed shape array, using 0 instead of '*' c = zlarf(v,tau,c,work,[side,incv,overwrite_c]) Constructing wrapper function "slartg"... cs,sn,r = slartg(f,g) Constructing wrapper function "dlartg"... cs,sn,r = dlartg(f,g) Constructing wrapper function "clartg"... cs,sn,r = clartg(f,g) Constructing wrapper function "zlartg"... cs,sn,r = zlartg(f,g) Constructing wrapper function "crot"... getarrdims:warning: assumed shape array, using 0 instead of '*' getarrdims:warning: assumed shape array, using 0 instead of '*' x,y = crot(x,y,c,s,[n,offx,incx,offy,incy,overwrite_x,overwrite_y]) Constructing wrapper function "zrot"... getarrdims:warning: assumed shape array, using 0 instead of '*' getarrdims:warning: assumed shape array, using 0 instead of '*' x,y = zrot(x,y,c,s,[n,offx,incx,offy,incy,overwrite_x,overwrite_y]) Constructing wrapper function "ilaver"... major,minor,patch = ilaver() Wrote C/API module "_flapack" to file "build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/linalg/_flapackmodule.c" Fortran 77 wrappers are saved to "build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/linalg/_flapack-f2pywrappers.f" adding 'build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/linalg/fortranobject.c' to sources. adding 'build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/linalg' to include_dirs. adding 'build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/linalg/_flapack-f2pywrappers.f' to sources. building extension "scipy.linalg._flinalg" sources f2py options: [] f2py:> build/src.linux-ppc64le-2.7/scipy/linalg/_flinalgmodule.c Reading fortran codes... Reading file 'scipy/linalg/src/det.f' (format:fix,strict) Reading file 'scipy/linalg/src/lu.f' (format:fix,strict) Post-processing... Block: _flinalg {'attrspec': ['intent(out)']} In: :_flinalg:scipy/linalg/src/det.f:ddet_c vars2fortran: No typespec for argument "info". Block: ddet_c {'attrspec': ['intent(out)']} In: :_flinalg:scipy/linalg/src/det.f:ddet_r vars2fortran: No typespec for argument "info". Block: ddet_r {'attrspec': ['intent(out)']} In: :_flinalg:scipy/linalg/src/det.f:sdet_c vars2fortran: No typespec for argument "info". Block: sdet_c {'attrspec': ['intent(out)']} In: :_flinalg:scipy/linalg/src/det.f:sdet_r vars2fortran: No typespec for argument "info". Block: sdet_r {'attrspec': ['intent(out)']} In: :_flinalg:scipy/linalg/src/det.f:zdet_c vars2fortran: No typespec for argument "info". Block: zdet_c {'attrspec': ['intent(out)']} In: :_flinalg:scipy/linalg/src/det.f:zdet_r vars2fortran: No typespec for argument "info". Block: zdet_r {'attrspec': ['intent(out)']} In: :_flinalg:scipy/linalg/src/det.f:cdet_c vars2fortran: No typespec for argument "info". Block: cdet_c {'attrspec': ['intent(out)']} In: :_flinalg:scipy/linalg/src/det.f:cdet_r vars2fortran: No typespec for argument "info". Block: cdet_r {'attrspec': ['intent(out)']} In: :_flinalg:scipy/linalg/src/lu.f:dlu_c vars2fortran: No typespec for argument "info". Block: dlu_c {'attrspec': ['intent(out)']} In: :_flinalg:scipy/linalg/src/lu.f:zlu_c vars2fortran: No typespec for argument "info". Block: zlu_c {'attrspec': ['intent(out)']} In: :_flinalg:scipy/linalg/src/lu.f:slu_c vars2fortran: No typespec for argument "info". Block: slu_c {'attrspec': ['intent(out)']} In: :_flinalg:scipy/linalg/src/lu.f:clu_c vars2fortran: No typespec for argument "info". Block: clu_c Post-processing (stage 2)... Building modules... Building module "_flinalg"... Constructing wrapper function "ddet_c"... det,info = ddet_c(a,[overwrite_a]) Constructing wrapper function "ddet_r"... det,info = ddet_r(a,[overwrite_a]) Constructing wrapper function "sdet_c"... det,info = sdet_c(a,[overwrite_a]) Constructing wrapper function "sdet_r"... det,info = sdet_r(a,[overwrite_a]) Constructing wrapper function "zdet_c"... det,info = zdet_c(a,[overwrite_a]) Constructing wrapper function "zdet_r"... det,info = zdet_r(a,[overwrite_a]) Constructing wrapper function "cdet_c"... det,info = cdet_c(a,[overwrite_a]) Constructing wrapper function "cdet_r"... det,info = cdet_r(a,[overwrite_a]) Constructing wrapper function "dlu_c"... p,l,u,info = dlu_c(a,[permute_l,overwrite_a]) Constructing wrapper function "zlu_c"... p,l,u,info = zlu_c(a,[permute_l,overwrite_a]) Constructing wrapper function "slu_c"... p,l,u,info = slu_c(a,[permute_l,overwrite_a]) Constructing wrapper function "clu_c"... p,l,u,info = clu_c(a,[permute_l,overwrite_a]) Wrote C/API module "_flinalg" to file "build/src.linux-ppc64le-2.7/scipy/linalg/_flinalgmodule.c" adding 'build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/linalg/fortranobject.c' to sources. adding 'build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/linalg' to include_dirs. copying /usr/lib64/python2.7/site-packages/numpy/f2py/src/fortranobject.c -> build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/linalg copying /usr/lib64/python2.7/site-packages/numpy/f2py/src/fortranobject.h -> build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/linalg building extension "scipy.linalg._interpolative" sources f2py options: [] f2py: scipy/linalg/interpolative.pyf "object of type 'type' has no len()" in evaluating 'len(list)' (available names: []) "object of type 'type' has no len()" in evaluating 'len(list)' (available names: []) "object of type 'type' has no len()" in evaluating 'len(list)' (available names: []) "object of type 'type' has no len()" in evaluating 'len(list)' (available names: []) "object of type 'type' has no len()" in evaluating 'len(list)' (available names: []) "object of type 'type' has no len()" in evaluating 'len(list)' (available names: []) Reading fortran codes... Reading file 'scipy/linalg/interpolative.pyf' (format:free) Post-processing... Block: _interpolative Block: id_srand Block: idd_frm Block: idd_sfrm Block: idd_frmi Block: idd_sfrmi Block: iddp_id Block: iddr_id Block: idd_reconid Block: idd_reconint Block: idd_copycols Block: idd_id2svd Block: idd_snorm In: scipy/linalg/interpolative.pyf:_interpolative:unknown_interface:idd_snorm get_useparameters: no module idd__user__routines info used by idd_snorm Block: idd_diffsnorm In: scipy/linalg/interpolative.pyf:_interpolative:unknown_interface:idd_diffsnorm get_useparameters: no module idd__user__routines info used by idd_diffsnorm Block: iddr_svd Block: iddp_svd Block: iddp_aid Block: idd_estrank Block: iddp_asvd Block: iddp_rid In: scipy/linalg/interpolative.pyf:_interpolative:unknown_interface:iddp_rid get_useparameters: no module idd__user__routines info used by iddp_rid Block: idd_findrank In: scipy/linalg/interpolative.pyf:_interpolative:unknown_interface:idd_findrank get_useparameters: no module idd__user__routines info used by idd_findrank Block: iddp_rsvd In: scipy/linalg/interpolative.pyf:_interpolative:unknown_interface:iddp_rsvd get_useparameters: no module idd__user__routines info used by iddp_rsvd Block: iddr_aid Block: iddr_aidi Block: iddr_asvd Block: iddr_rid In: scipy/linalg/interpolative.pyf:_interpolative:unknown_interface:iddr_rid get_useparameters: no module idd__user__routines info used by iddr_rid Block: iddr_rsvd In: scipy/linalg/interpolative.pyf:_interpolative:unknown_interface:iddr_rsvd get_useparameters: no module idd__user__routines info used by iddr_rsvd Block: idz_frm Block: idz_sfrm Block: idz_frmi Block: idz_sfrmi Block: idzp_id Block: idzr_id Block: idz_reconid Block: idz_reconint Block: idz_copycols Block: idz_id2svd Block: idz_snorm In: scipy/linalg/interpolative.pyf:_interpolative:unknown_interface:idz_snorm get_useparameters: no module idz__user__routines info used by idz_snorm Block: idz_diffsnorm In: scipy/linalg/interpolative.pyf:_interpolative:unknown_interface:idz_diffsnorm get_useparameters: no module idz__user__routines info used by idz_diffsnorm Block: idzr_svd Block: idzp_svd Block: idzp_aid Block: idz_estrank Block: idzp_asvd Block: idzp_rid In: scipy/linalg/interpolative.pyf:_interpolative:unknown_interface:idzp_rid get_useparameters: no module idz__user__routines info used by idzp_rid Block: idz_findrank In: scipy/linalg/interpolative.pyf:_interpolative:unknown_interface:idz_findrank get_useparameters: no module idz__user__routines info used by idz_findrank Block: idzp_rsvd In: scipy/linalg/interpolative.pyf:_interpolative:unknown_interface:idzp_rsvd get_useparameters: no module idz__user__routines info used by idzp_rsvd Block: idzr_aid Block: idzr_aidi Block: idzr_asvd Block: idzr_rid In: scipy/linalg/interpolative.pyf:_interpolative:unknown_interface:idzr_rid get_useparameters: no module idz__user__routines info used by idzr_rid Block: idzr_rsvd In: scipy/linalg/interpolative.pyf:_interpolative:unknown_interface:idzr_rsvd get_useparameters: no module idz__user__routines info used by idzr_rsvd Block: idd__user__routines Block: idd_user_interface Block: matvect Block: matvec Block: matvect2 Block: matvec2 Block: idz__user__routines Block: idz_user_interface Block: matveca Block: matvec Block: matveca2 Block: matvec2 Post-processing (stage 2)... Building modules... Constructing call-back function "cb_matvect_in_idd__user__routines" def matvect(x,[m,n,p1,p2,p3,p4]): return y Constructing call-back function "cb_matvec_in_idd__user__routines" def matvec(x,[n,m,p1,p2,p3,p4]): return y Constructing call-back function "cb_matvect2_in_idd__user__routines" def matvect2(x,[m,n,p1,p2,p3,p4]): return y Constructing call-back function "cb_matvec2_in_idd__user__routines" def matvec2(x,[n,m,p1,p2,p3,p4]): return y Constructing call-back function "cb_matveca_in_idz__user__routines" def matveca(x,[m,n,p1,p2,p3,p4]): return y Constructing call-back function "cb_matvec_in_idz__user__routines" def matvec(x,[n,m,p1,p2,p3,p4]): return y Constructing call-back function "cb_matveca2_in_idz__user__routines" def matveca2(x,[m,n,p1,p2,p3,p4]): return y Constructing call-back function "cb_matvec2_in_idz__user__routines" def matvec2(x,[n,m,p1,p2,p3,p4]): return y Building module "_interpolative"... Constructing wrapper function "id_srand"... r = id_srand(n) Constructing wrapper function "id_srandi"... id_srandi(t) Constructing wrapper function "id_srando"... id_srando() Constructing wrapper function "idd_frm"... y = idd_frm(n,w,x,[m]) Constructing wrapper function "idd_sfrm"... y = idd_sfrm(l,n,w,x,[m]) Constructing wrapper function "idd_frmi"... n,w = idd_frmi(m) Constructing wrapper function "idd_sfrmi"... n,w = idd_sfrmi(l,m) Constructing wrapper function "iddp_id"... krank,list,rnorms = iddp_id(eps,a,[m,n]) Constructing wrapper function "iddr_id"... list,rnorms = iddr_id(a,krank,[m,n]) Constructing wrapper function "idd_reconid"... approx = idd_reconid(col,list,proj,[m,krank,n]) Constructing wrapper function "idd_reconint"... p = idd_reconint(list,proj,[n,krank]) Constructing wrapper function "idd_copycols"... getarrdims:warning: assumed shape array, using 0 instead of '*' col = idd_copycols(a,krank,list,[m,n]) Constructing wrapper function "idd_id2svd"... u,v,s,ier = idd_id2svd(b,list,proj,[m,krank,n,w]) Constructing wrapper function "idd_snorm"... snorm,v = idd_snorm(m,n,matvect,matvec,its,[p1t,p2t,p3t,p4t,p1,p2,p3,p4,u,matvect_extra_args,matvec_extra_args]) Constructing wrapper function "idd_diffsnorm"... snorm = idd_diffsnorm(m,n,matvect,matvect2,matvec,matvec2,its,[p1t,p2t,p3t,p4t,p1t2,p2t2,p3t2,p4t2,p1,p2,p3,p4,p12,p22,p32,p42,w,matvect_extra_args,matvect2_extra_args,matvec_extra_args,matvec2_extra_args]) Constructing wrapper function "iddr_svd"... u,v,s,ier = iddr_svd(a,krank,[m,n,r]) Constructing wrapper function "iddp_svd"... krank,iu,iv,is,w,ier = iddp_svd(eps,a,[m,n]) Constructing wrapper function "iddp_aid"... getarrdims:warning: assumed shape array, using 0 instead of '*' krank,list,proj = iddp_aid(eps,a,work,proj,[m,n]) Constructing wrapper function "idd_estrank"... getarrdims:warning: assumed shape array, using 0 instead of '*' krank,ra = idd_estrank(eps,a,w,ra,[m,n]) Constructing wrapper function "iddp_asvd"... getarrdims:warning: assumed shape array, using 0 instead of '*' krank,iu,iv,is,w,ier = iddp_asvd(eps,a,winit,w,[m,n]) Constructing wrapper function "iddp_rid"... getarrdims:warning: assumed shape array, using 0 instead of '*' krank,list,proj,ier = iddp_rid(eps,m,n,matvect,proj,[p1,p2,p3,p4,matvect_extra_args]) Constructing wrapper function "idd_findrank"... krank,ra,ier = idd_findrank(eps,m,n,matvect,[p1,p2,p3,p4,w,matvect_extra_args]) Constructing wrapper function "iddp_rsvd"... krank,iu,iv,is,w,ier = iddp_rsvd(eps,m,n,matvect,matvec,[p1t,p2t,p3t,p4t,p1,p2,p3,p4,matvect_extra_args,matvec_extra_args]) Constructing wrapper function "iddr_aid"... list,proj = iddr_aid(a,krank,w,[m,n]) Constructing wrapper function "iddr_aidi"... w = iddr_aidi(m,n,krank) Constructing wrapper function "iddr_asvd"... u,v,s,ier = iddr_asvd(a,krank,w,[m,n]) Constructing wrapper function "iddr_rid"... list,proj = iddr_rid(m,n,matvect,krank,[p1,p2,p3,p4,matvect_extra_args]) Constructing wrapper function "iddr_rsvd"... u,v,s,ier = iddr_rsvd(m,n,matvect,matvec,krank,[p1t,p2t,p3t,p4t,p1,p2,p3,p4,w,matvect_extra_args,matvec_extra_args]) Constructing wrapper function "idz_frm"... y = idz_frm(n,w,x,[m]) Constructing wrapper function "idz_sfrm"... y = idz_sfrm(l,n,w,x,[m]) Constructing wrapper function "idz_frmi"... n,w = idz_frmi(m) Constructing wrapper function "idz_sfrmi"... n,w = idz_sfrmi(l,m) Constructing wrapper function "idzp_id"... krank,list,rnorms = idzp_id(eps,a,[m,n]) Constructing wrapper function "idzr_id"... list,rnorms = idzr_id(a,krank,[m,n]) Constructing wrapper function "idz_reconid"... approx = idz_reconid(col,list,proj,[m,krank,n]) Constructing wrapper function "idz_reconint"... p = idz_reconint(list,proj,[n,krank]) Constructing wrapper function "idz_copycols"... getarrdims:warning: assumed shape array, using 0 instead of '*' col = idz_copycols(a,krank,list,[m,n]) Constructing wrapper function "idz_id2svd"... u,v,s,ier = idz_id2svd(b,list,proj,[m,krank,n,w]) Constructing wrapper function "idz_snorm"... snorm,v = idz_snorm(m,n,matveca,matvec,its,[p1a,p2a,p3a,p4a,p1,p2,p3,p4,u,matveca_extra_args,matvec_extra_args]) Constructing wrapper function "idz_diffsnorm"... snorm = idz_diffsnorm(m,n,matveca,matveca2,matvec,matvec2,its,[p1a,p2a,p3a,p4a,p1a2,p2a2,p3a2,p4a2,p1,p2,p3,p4,p12,p22,p32,p42,w,matveca_extra_args,matveca2_extra_args,matvec_extra_args,matvec2_extra_args]) Constructing wrapper function "idzr_svd"... u,v,s,ier = idzr_svd(a,krank,[m,n,r]) Constructing wrapper function "idzp_svd"... krank,iu,iv,is,w,ier = idzp_svd(eps,a,[m,n]) Constructing wrapper function "idzp_aid"... getarrdims:warning: assumed shape array, using 0 instead of '*' krank,list,proj = idzp_aid(eps,a,work,proj,[m,n]) Constructing wrapper function "idz_estrank"... getarrdims:warning: assumed shape array, using 0 instead of '*' krank,ra = idz_estrank(eps,a,w,ra,[m,n]) Constructing wrapper function "idzp_asvd"... getarrdims:warning: assumed shape array, using 0 instead of '*' krank,iu,iv,is,w,ier = idzp_asvd(eps,a,winit,w,[m,n]) Constructing wrapper function "idzp_rid"... getarrdims:warning: assumed shape array, using 0 instead of '*' krank,list,proj,ier = idzp_rid(eps,m,n,matveca,proj,[p1,p2,p3,p4,matveca_extra_args]) Constructing wrapper function "idz_findrank"... krank,ra,ier = idz_findrank(eps,m,n,matveca,[p1,p2,p3,p4,w,matveca_extra_args]) Constructing wrapper function "idzp_rsvd"... krank,iu,iv,is,w,ier = idzp_rsvd(eps,m,n,matveca,matvec,[p1a,p2a,p3a,p4a,p1,p2,p3,p4,matveca_extra_args,matvec_extra_args]) Constructing wrapper function "idzr_aid"... list,proj = idzr_aid(a,krank,w,[m,n]) Constructing wrapper function "idzr_aidi"... w = idzr_aidi(m,n,krank) Constructing wrapper function "idzr_asvd"... u,v,s,ier = idzr_asvd(a,krank,w,[m,n]) Constructing wrapper function "idzr_rid"... list,proj = idzr_rid(m,n,matveca,krank,[p1,p2,p3,p4,matveca_extra_args]) Constructing wrapper function "idzr_rsvd"... u,v,s,ier = idzr_rsvd(m,n,matveca,matvec,krank,[p1a,p2a,p3a,p4a,p1,p2,p3,p4,w,matveca_extra_args,matvec_extra_args]) Wrote C/API module "_interpolative" to file "build/src.linux-ppc64le-2.7/scipy/linalg/_interpolativemodule.c" adding 'build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/linalg/fortranobject.c' to sources. adding 'build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/linalg' to include_dirs. building extension "scipy.linalg._solve_toeplitz" sources building extension "scipy.linalg.cython_blas" sources building extension "scipy.linalg.cython_lapack" sources building extension "scipy.linalg._decomp_update" sources building extension "scipy.odr.__odrpack" sources building extension "scipy.optimize._minpack" sources building extension "scipy.optimize._zeros" sources building extension "scipy.optimize._lbfgsb" sources creating build/src.linux-ppc64le-2.7/scipy/optimize creating build/src.linux-ppc64le-2.7/scipy/optimize/lbfgsb f2py options: [] f2py: scipy/optimize/lbfgsb/lbfgsb.pyf Reading fortran codes... Reading file 'scipy/optimize/lbfgsb/lbfgsb.pyf' (format:free) Post-processing... Block: _lbfgsb Block: setulb Post-processing (stage 2)... Building modules... Building module "_lbfgsb"... Constructing wrapper function "setulb"... setulb(m,x,l,u,nbd,f,g,factr,pgtol,wa,iwa,task,iprint,csave,lsave,isave,dsave,maxls,[n]) Wrote C/API module "_lbfgsb" to file "build/src.linux-ppc64le-2.7/scipy/optimize/lbfgsb/_lbfgsbmodule.c" adding 'build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/optimize/lbfgsb/fortranobject.c' to sources. adding 'build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/optimize/lbfgsb' to include_dirs. creating build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/optimize creating build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/optimize/lbfgsb copying /usr/lib64/python2.7/site-packages/numpy/f2py/src/fortranobject.c -> build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/optimize/lbfgsb copying /usr/lib64/python2.7/site-packages/numpy/f2py/src/fortranobject.h -> build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/optimize/lbfgsb building extension "scipy.optimize.moduleTNC" sources building extension "scipy.optimize._cobyla" sources creating build/src.linux-ppc64le-2.7/scipy/optimize/cobyla f2py options: [] f2py: scipy/optimize/cobyla/cobyla.pyf Reading fortran codes... Reading file 'scipy/optimize/cobyla/cobyla.pyf' (format:free) Post-processing... Block: _cobyla__user__routines Block: _cobyla_user_interface Block: calcfc Block: _cobyla Block: minimize In: scipy/optimize/cobyla/cobyla.pyf:_cobyla:unknown_interface:minimize get_useparameters: no module _cobyla__user__routines info used by minimize Post-processing (stage 2)... Building modules... Constructing call-back function "cb_calcfc_in__cobyla__user__routines" def calcfc(x,con): return f Building module "_cobyla"... Constructing wrapper function "minimize"... x,dinfo = minimize(calcfc,m,x,rhobeg,rhoend,dinfo,[iprint,maxfun,calcfc_extra_args]) Wrote C/API module "_cobyla" to file "build/src.linux-ppc64le-2.7/scipy/optimize/cobyla/_cobylamodule.c" adding 'build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/optimize/cobyla/fortranobject.c' to sources. adding 'build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/optimize/cobyla' to include_dirs. creating build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/optimize/cobyla copying /usr/lib64/python2.7/site-packages/numpy/f2py/src/fortranobject.c -> build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/optimize/cobyla copying /usr/lib64/python2.7/site-packages/numpy/f2py/src/fortranobject.h -> build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/optimize/cobyla building extension "scipy.optimize.minpack2" sources creating build/src.linux-ppc64le-2.7/scipy/optimize/minpack2 f2py options: [] f2py: scipy/optimize/minpack2/minpack2.pyf Reading fortran codes... Reading file 'scipy/optimize/minpack2/minpack2.pyf' (format:free) Post-processing... Block: minpack2 Block: dcsrch Block: dcstep Post-processing (stage 2)... Building modules... Building module "minpack2"... Constructing wrapper function "dcsrch"... stp,f,g,task = dcsrch(stp,f,g,ftol,gtol,xtol,task,stpmin,stpmax,isave,dsave) Constructing wrapper function "dcstep"... stx,fx,dx,sty,fy,dy,stp,brackt = dcstep(stx,fx,dx,sty,fy,dy,stp,fp,dp,brackt,stpmin,stpmax) Wrote C/API module "minpack2" to file "build/src.linux-ppc64le-2.7/scipy/optimize/minpack2/minpack2module.c" adding 'build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/optimize/minpack2/fortranobject.c' to sources. adding 'build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/optimize/minpack2' to include_dirs. creating build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/optimize/minpack2 copying /usr/lib64/python2.7/site-packages/numpy/f2py/src/fortranobject.c -> build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/optimize/minpack2 copying /usr/lib64/python2.7/site-packages/numpy/f2py/src/fortranobject.h -> build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/optimize/minpack2 building extension "scipy.optimize._slsqp" sources creating build/src.linux-ppc64le-2.7/scipy/optimize/slsqp f2py options: [] f2py: scipy/optimize/slsqp/slsqp.pyf Reading fortran codes... Reading file 'scipy/optimize/slsqp/slsqp.pyf' (format:free) Post-processing... Block: _slsqp Block: slsqp Post-processing (stage 2)... Building modules... Building module "_slsqp"... Constructing wrapper function "slsqp"... slsqp(m,meq,x,xl,xu,f,c,g,a,acc,iter,mode,w,jw,[la,n,l_w,l_jw]) Wrote C/API module "_slsqp" to file "build/src.linux-ppc64le-2.7/scipy/optimize/slsqp/_slsqpmodule.c" adding 'build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/optimize/slsqp/fortranobject.c' to sources. adding 'build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/optimize/slsqp' to include_dirs. creating build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/optimize/slsqp copying /usr/lib64/python2.7/site-packages/numpy/f2py/src/fortranobject.c -> build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/optimize/slsqp copying /usr/lib64/python2.7/site-packages/numpy/f2py/src/fortranobject.h -> build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/optimize/slsqp building extension "scipy.optimize._nnls" sources creating build/src.linux-ppc64le-2.7/scipy/optimize/nnls f2py options: [] f2py: scipy/optimize/nnls/nnls.pyf Reading fortran codes... Reading file 'scipy/optimize/nnls/nnls.pyf' (format:free) crackline: groupcounter=1 groupname={0: '', 1: 'python module', 2: 'interface', 3: 'subroutine'} crackline: Mismatch of blocks encountered. Trying to fix it by assuming "end" statement. Post-processing... Block: _nnls Block: nnls Post-processing (stage 2)... Building modules... Building module "_nnls"... Constructing wrapper function "nnls"... getarrdims:warning: assumed shape array, using 0 instead of '*' getarrdims:warning: assumed shape array, using 0 instead of '*' getarrdims:warning: assumed shape array, using 0 instead of '*' getarrdims:warning: assumed shape array, using 0 instead of '*' getarrdims:warning: assumed shape array, using 0 instead of '*' x,rnorm,mode = nnls(a,m,n,b,w,zz,index_bn,[mda,overwrite_a,overwrite_b]) Wrote C/API module "_nnls" to file "build/src.linux-ppc64le-2.7/scipy/optimize/nnls/_nnlsmodule.c" adding 'build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/optimize/nnls/fortranobject.c' to sources. adding 'build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/optimize/nnls' to include_dirs. creating build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/optimize/nnls copying /usr/lib64/python2.7/site-packages/numpy/f2py/src/fortranobject.c -> build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/optimize/nnls copying /usr/lib64/python2.7/site-packages/numpy/f2py/src/fortranobject.h -> build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/optimize/nnls building extension "scipy.optimize._group_columns" sources building extension "scipy.optimize._lsq.givens_elimination" sources building extension "scipy.optimize._trlib._trlib" sources building extension "scipy.signal.sigtools" sources creating build/src.linux-ppc64le-2.7/scipy/signal conv_template:> build/src.linux-ppc64le-2.7/scipy/signal/lfilter.c conv_template:> build/src.linux-ppc64le-2.7/scipy/signal/correlate_nd.c building extension "scipy.signal._spectral" sources building extension "scipy.signal._max_len_seq_inner" sources building extension "scipy.signal._upfirdn_apply" sources building extension "scipy.signal.spline" sources building extension "scipy.sparse.linalg.isolve._iterative" sources creating build/src.linux-ppc64le-2.7/scipy/sparse creating build/src.linux-ppc64le-2.7/scipy/sparse/linalg creating build/src.linux-ppc64le-2.7/scipy/sparse/linalg/isolve creating build/src.linux-ppc64le-2.7/scipy/sparse/linalg/isolve/iterative from_template:> build/src.linux-ppc64le-2.7/scipy/sparse/linalg/isolve/iterative/STOPTEST2.f from_template:> build/src.linux-ppc64le-2.7/scipy/sparse/linalg/isolve/iterative/getbreak.f from_template:> build/src.linux-ppc64le-2.7/scipy/sparse/linalg/isolve/iterative/BiCGREVCOM.f from_template:> build/src.linux-ppc64le-2.7/scipy/sparse/linalg/isolve/iterative/BiCGSTABREVCOM.f from_template:> build/src.linux-ppc64le-2.7/scipy/sparse/linalg/isolve/iterative/CGREVCOM.f from_template:> build/src.linux-ppc64le-2.7/scipy/sparse/linalg/isolve/iterative/CGSREVCOM.f from_template:> build/src.linux-ppc64le-2.7/scipy/sparse/linalg/isolve/iterative/GMRESREVCOM.f from_template:> build/src.linux-ppc64le-2.7/scipy/sparse/linalg/isolve/iterative/QMRREVCOM.f from_template:> build/src.linux-ppc64le-2.7/scipy/sparse/linalg/isolve/iterative/_iterative.pyf creating build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/sparse creating build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/sparse/linalg creating build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/sparse/linalg/isolve creating build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/sparse/linalg/isolve/iterative f2py options: [] f2py: build/src.linux-ppc64le-2.7/scipy/sparse/linalg/isolve/iterative/_iterative.pyf Reading fortran codes... Reading file 'build/src.linux-ppc64le-2.7/scipy/sparse/linalg/isolve/iterative/_iterative.pyf' (format:free) Post-processing... Block: _iterative Block: sbicgrevcom Block: dbicgrevcom Block: cbicgrevcom Block: zbicgrevcom Block: sbicgstabrevcom Block: dbicgstabrevcom Block: cbicgstabrevcom Block: zbicgstabrevcom Block: scgrevcom Block: dcgrevcom Block: ccgrevcom Block: zcgrevcom Block: scgsrevcom Block: dcgsrevcom Block: ccgsrevcom Block: zcgsrevcom Block: sqmrrevcom Block: dqmrrevcom Block: cqmrrevcom Block: zqmrrevcom Block: sgmresrevcom Block: dgmresrevcom Block: cgmresrevcom Block: zgmresrevcom Block: sstoptest2 Block: dstoptest2 Block: cstoptest2 Block: zstoptest2 Post-processing (stage 2)... Building modules... Building module "_iterative"... Constructing wrapper function "sbicgrevcom"... x,iter,resid,info,ndx1,ndx2,sclr1,sclr2,ijob = sbicgrevcom(b,x,work,iter,resid,info,ndx1,ndx2,ijob) Constructing wrapper function "dbicgrevcom"... x,iter,resid,info,ndx1,ndx2,sclr1,sclr2,ijob = dbicgrevcom(b,x,work,iter,resid,info,ndx1,ndx2,ijob) Constructing wrapper function "cbicgrevcom"... x,iter,resid,info,ndx1,ndx2,sclr1,sclr2,ijob = cbicgrevcom(b,x,work,iter,resid,info,ndx1,ndx2,ijob) Constructing wrapper function "zbicgrevcom"... x,iter,resid,info,ndx1,ndx2,sclr1,sclr2,ijob = zbicgrevcom(b,x,work,iter,resid,info,ndx1,ndx2,ijob) Constructing wrapper function "sbicgstabrevcom"... x,iter,resid,info,ndx1,ndx2,sclr1,sclr2,ijob = sbicgstabrevcom(b,x,work,iter,resid,info,ndx1,ndx2,ijob) Constructing wrapper function "dbicgstabrevcom"... x,iter,resid,info,ndx1,ndx2,sclr1,sclr2,ijob = dbicgstabrevcom(b,x,work,iter,resid,info,ndx1,ndx2,ijob) Constructing wrapper function "cbicgstabrevcom"... x,iter,resid,info,ndx1,ndx2,sclr1,sclr2,ijob = cbicgstabrevcom(b,x,work,iter,resid,info,ndx1,ndx2,ijob) Constructing wrapper function "zbicgstabrevcom"... x,iter,resid,info,ndx1,ndx2,sclr1,sclr2,ijob = zbicgstabrevcom(b,x,work,iter,resid,info,ndx1,ndx2,ijob) Constructing wrapper function "scgrevcom"... x,iter,resid,info,ndx1,ndx2,sclr1,sclr2,ijob = scgrevcom(b,x,work,iter,resid,info,ndx1,ndx2,ijob) Constructing wrapper function "dcgrevcom"... x,iter,resid,info,ndx1,ndx2,sclr1,sclr2,ijob = dcgrevcom(b,x,work,iter,resid,info,ndx1,ndx2,ijob) Constructing wrapper function "ccgrevcom"... x,iter,resid,info,ndx1,ndx2,sclr1,sclr2,ijob = ccgrevcom(b,x,work,iter,resid,info,ndx1,ndx2,ijob) Constructing wrapper function "zcgrevcom"... x,iter,resid,info,ndx1,ndx2,sclr1,sclr2,ijob = zcgrevcom(b,x,work,iter,resid,info,ndx1,ndx2,ijob) Constructing wrapper function "scgsrevcom"... x,iter,resid,info,ndx1,ndx2,sclr1,sclr2,ijob = scgsrevcom(b,x,work,iter,resid,info,ndx1,ndx2,ijob) Constructing wrapper function "dcgsrevcom"... x,iter,resid,info,ndx1,ndx2,sclr1,sclr2,ijob = dcgsrevcom(b,x,work,iter,resid,info,ndx1,ndx2,ijob) Constructing wrapper function "ccgsrevcom"... x,iter,resid,info,ndx1,ndx2,sclr1,sclr2,ijob = ccgsrevcom(b,x,work,iter,resid,info,ndx1,ndx2,ijob) Constructing wrapper function "zcgsrevcom"... x,iter,resid,info,ndx1,ndx2,sclr1,sclr2,ijob = zcgsrevcom(b,x,work,iter,resid,info,ndx1,ndx2,ijob) Constructing wrapper function "sqmrrevcom"... x,iter,resid,info,ndx1,ndx2,sclr1,sclr2,ijob = sqmrrevcom(b,x,work,iter,resid,info,ndx1,ndx2,ijob) Constructing wrapper function "dqmrrevcom"... x,iter,resid,info,ndx1,ndx2,sclr1,sclr2,ijob = dqmrrevcom(b,x,work,iter,resid,info,ndx1,ndx2,ijob) Constructing wrapper function "cqmrrevcom"... x,iter,resid,info,ndx1,ndx2,sclr1,sclr2,ijob = cqmrrevcom(b,x,work,iter,resid,info,ndx1,ndx2,ijob) Constructing wrapper function "zqmrrevcom"... x,iter,resid,info,ndx1,ndx2,sclr1,sclr2,ijob = zqmrrevcom(b,x,work,iter,resid,info,ndx1,ndx2,ijob) Constructing wrapper function "sgmresrevcom"... x,iter,resid,info,ndx1,ndx2,sclr1,sclr2,ijob = sgmresrevcom(b,x,restrt,work,work2,iter,resid,info,ndx1,ndx2,ijob) Constructing wrapper function "dgmresrevcom"... x,iter,resid,info,ndx1,ndx2,sclr1,sclr2,ijob = dgmresrevcom(b,x,restrt,work,work2,iter,resid,info,ndx1,ndx2,ijob) Constructing wrapper function "cgmresrevcom"... x,iter,resid,info,ndx1,ndx2,sclr1,sclr2,ijob = cgmresrevcom(b,x,restrt,work,work2,iter,resid,info,ndx1,ndx2,ijob) Constructing wrapper function "zgmresrevcom"... x,iter,resid,info,ndx1,ndx2,sclr1,sclr2,ijob = zgmresrevcom(b,x,restrt,work,work2,iter,resid,info,ndx1,ndx2,ijob) Constructing wrapper function "sstoptest2"... bnrm2,resid,info = sstoptest2(r,b,bnrm2,tol,info) Constructing wrapper function "dstoptest2"... bnrm2,resid,info = dstoptest2(r,b,bnrm2,tol,info) Constructing wrapper function "cstoptest2"... bnrm2,resid,info = cstoptest2(r,b,bnrm2,tol,info) Constructing wrapper function "zstoptest2"... bnrm2,resid,info = zstoptest2(r,b,bnrm2,tol,info) Wrote C/API module "_iterative" to file "build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/sparse/linalg/isolve/iterative/_iterativemodule.c" adding 'build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/sparse/linalg/isolve/iterative/fortranobject.c' to sources. adding 'build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/sparse/linalg/isolve/iterative' to include_dirs. creating build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/sparse creating build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/sparse/linalg creating build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/sparse/linalg/isolve creating build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/sparse/linalg/isolve/iterative copying /usr/lib64/python2.7/site-packages/numpy/f2py/src/fortranobject.c -> build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/sparse/linalg/isolve/iterative copying /usr/lib64/python2.7/site-packages/numpy/f2py/src/fortranobject.h -> build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/sparse/linalg/isolve/iterative building extension "scipy.sparse.linalg.dsolve._superlu" sources building extension "scipy.sparse.linalg.eigen.arpack._arpack" sources creating build/src.linux-ppc64le-2.7/scipy/sparse/linalg/eigen creating build/src.linux-ppc64le-2.7/scipy/sparse/linalg/eigen/arpack from_template:> build/src.linux-ppc64le-2.7/scipy/sparse/linalg/eigen/arpack/arpack.pyf creating build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/sparse/linalg/eigen creating build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/sparse/linalg/eigen/arpack f2py options: [] f2py: build/src.linux-ppc64le-2.7/scipy/sparse/linalg/eigen/arpack/arpack.pyf Reading fortran codes... Reading file 'build/src.linux-ppc64le-2.7/scipy/sparse/linalg/eigen/arpack/arpack.pyf' (format:free) Line #5 in build/src.linux-ppc64le-2.7/scipy/sparse/linalg/eigen/arpack/arpack.pyf:" <_rd=real,double precision>" crackline:1: No pattern for line Line #6 in build/src.linux-ppc64le-2.7/scipy/sparse/linalg/eigen/arpack/arpack.pyf:" <_cd=complex,double complex>" crackline:1: No pattern for line Post-processing... Block: _arpack Block: ssaupd Block: dsaupd Block: sseupd Block: dseupd Block: snaupd Block: dnaupd Block: sneupd Block: dneupd Block: cnaupd Block: znaupd Block: cneupd Block: zneupd Post-processing (stage 2)... Building modules... Building module "_arpack"... Constructing wrapper function "ssaupd"... ido,tol,resid,v,iparam,ipntr,info = ssaupd(ido,bmat,which,nev,tol,resid,v,iparam,ipntr,workd,workl,info,[n,ncv,ldv,lworkl]) Constructing wrapper function "dsaupd"... ido,tol,resid,v,iparam,ipntr,info = dsaupd(ido,bmat,which,nev,tol,resid,v,iparam,ipntr,workd,workl,info,[n,ncv,ldv,lworkl]) Constructing wrapper function "sseupd"... d,z,info = sseupd(rvec,howmny,select,sigma,bmat,which,nev,tol,resid,v,iparam,ipntr,workd,workl,info,[ldz,n,ncv,ldv,lworkl]) Constructing wrapper function "dseupd"... d,z,info = dseupd(rvec,howmny,select,sigma,bmat,which,nev,tol,resid,v,iparam,ipntr,workd,workl,info,[ldz,n,ncv,ldv,lworkl]) Constructing wrapper function "snaupd"... ido,tol,resid,v,iparam,ipntr,info = snaupd(ido,bmat,which,nev,tol,resid,v,iparam,ipntr,workd,workl,info,[n,ncv,ldv,lworkl]) Constructing wrapper function "dnaupd"... ido,tol,resid,v,iparam,ipntr,info = dnaupd(ido,bmat,which,nev,tol,resid,v,iparam,ipntr,workd,workl,info,[n,ncv,ldv,lworkl]) Constructing wrapper function "sneupd"... dr,di,z,info = sneupd(rvec,howmny,select,sigmar,sigmai,workev,bmat,which,nev,tol,resid,v,iparam,ipntr,workd,workl,info,[ldz,n,ncv,ldv,lworkl]) Constructing wrapper function "dneupd"... dr,di,z,info = dneupd(rvec,howmny,select,sigmar,sigmai,workev,bmat,which,nev,tol,resid,v,iparam,ipntr,workd,workl,info,[ldz,n,ncv,ldv,lworkl]) Constructing wrapper function "cnaupd"... ido,tol,resid,v,iparam,ipntr,info = cnaupd(ido,bmat,which,nev,tol,resid,v,iparam,ipntr,workd,workl,rwork,info,[n,ncv,ldv,lworkl]) Constructing wrapper function "znaupd"... ido,tol,resid,v,iparam,ipntr,info = znaupd(ido,bmat,which,nev,tol,resid,v,iparam,ipntr,workd,workl,rwork,info,[n,ncv,ldv,lworkl]) Constructing wrapper function "cneupd"... d,z,info = cneupd(rvec,howmny,select,sigma,workev,bmat,which,nev,tol,resid,v,iparam,ipntr,workd,workl,rwork,info,[ldz,n,ncv,ldv,lworkl]) Constructing wrapper function "zneupd"... d,z,info = zneupd(rvec,howmny,select,sigma,workev,bmat,which,nev,tol,resid,v,iparam,ipntr,workd,workl,rwork,info,[ldz,n,ncv,ldv,lworkl]) Constructing COMMON block support for "debug"... logfil,ndigit,mgetv0,msaupd,msaup2,msaitr,mseigt,msapps,msgets,mseupd,mnaupd,mnaup2,mnaitr,mneigh,mnapps,mngets,mneupd,mcaupd,mcaup2,mcaitr,mceigh,mcapps,mcgets,mceupd Constructing COMMON block support for "timing"... nopx,nbx,nrorth,nitref,nrstrt,tsaupd,tsaup2,tsaitr,tseigt,tsgets,tsapps,tsconv,tnaupd,tnaup2,tnaitr,tneigh,tngets,tnapps,tnconv,tcaupd,tcaup2,tcaitr,tceigh,tcgets,tcapps,tcconv,tmvopx,tmvbx,tgetv0,titref,trvec Wrote C/API module "_arpack" to file "build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/sparse/linalg/eigen/arpack/_arpackmodule.c" Fortran 77 wrappers are saved to "build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/sparse/linalg/eigen/arpack/_arpack-f2pywrappers.f" adding 'build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/sparse/linalg/eigen/arpack/fortranobject.c' to sources. adding 'build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/sparse/linalg/eigen/arpack' to include_dirs. creating build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/sparse/linalg/eigen creating build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/sparse/linalg/eigen/arpack copying /usr/lib64/python2.7/site-packages/numpy/f2py/src/fortranobject.c -> build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/sparse/linalg/eigen/arpack copying /usr/lib64/python2.7/site-packages/numpy/f2py/src/fortranobject.h -> build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/sparse/linalg/eigen/arpack adding 'build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/sparse/linalg/eigen/arpack/_arpack-f2pywrappers.f' to sources. building extension "scipy.sparse.csgraph._shortest_path" sources building extension "scipy.sparse.csgraph._traversal" sources building extension "scipy.sparse.csgraph._min_spanning_tree" sources building extension "scipy.sparse.csgraph._reordering" sources building extension "scipy.sparse.csgraph._tools" sources building extension "scipy.sparse._csparsetools" sources building extension "scipy.sparse._sparsetools" sources [generate_sparsetools] generating 'scipy/sparse/sparsetools/bsr_impl.h' [generate_sparsetools] generating 'scipy/sparse/sparsetools/csr_impl.h' [generate_sparsetools] generating 'scipy/sparse/sparsetools/csc_impl.h' [generate_sparsetools] generating 'scipy/sparse/sparsetools/other_impl.h' [generate_sparsetools] generating 'scipy/sparse/sparsetools/sparsetools_impl.h' building extension "scipy.spatial.qhull" sources building extension "scipy.spatial.ckdtree" sources building extension "scipy.spatial._distance_wrap" sources building extension "scipy.spatial._voronoi" sources building extension "scipy.spatial._hausdorff" sources building extension "scipy.special.specfun" sources creating build/src.linux-ppc64le-2.7/scipy/special f2py options: ['--no-wrap-functions'] f2py: scipy/special/specfun.pyf Reading fortran codes... Reading file 'scipy/special/specfun.pyf' (format:free) Post-processing... Block: specfun Block: clqmn Block: lqmn Block: clpmn Block: jdzo Block: bernob Block: bernoa Block: lpmns Block: eulera Block: clqn Block: airyzo Block: eulerb Block: cva1 Block: lqnb Block: lamv Block: lagzo Block: legzo Block: pbdv Block: cerzo Block: lamn Block: clpn Block: lqmns Block: chgm Block: lpmn Block: fcszo Block: aswfb Block: lqna Block: cpbdn Block: lpn Block: fcoef Block: rcty Block: lpni Block: cyzo Block: othpl Block: klvnzo Block: jyzo Block: rctj Block: herzo Block: pbvv Block: segv Post-processing (stage 2)... Building modules... Building module "specfun"... Constructing wrapper function "clqmn"... cqm,cqd = clqmn(m,n,z) Constructing wrapper function "lqmn"... qm,qd = lqmn(m,n,x) Constructing wrapper function "clpmn"... cpm,cpd = clpmn(m,n,x,y,ntype) Constructing wrapper function "jdzo"... n,m,pcode,zo = jdzo(nt) Constructing wrapper function "bernob"... bn = bernob(n) Constructing wrapper function "bernoa"... bn = bernoa(n) Constructing wrapper function "lpmns"... pm,pd = lpmns(m,n,x) Constructing wrapper function "eulera"... en = eulera(n) Constructing wrapper function "clqn"... cqn,cqd = clqn(n,z) Constructing wrapper function "airyzo"... xa,xb,xc,xd = airyzo(nt,[kf]) Constructing wrapper function "eulerb"... en = eulerb(n) Constructing wrapper function "cva1"... cv = cva1(kd,m,q) Constructing wrapper function "lqnb"... qn,qd = lqnb(n,x) Constructing wrapper function "lamv"... vm,vl,dl = lamv(v,x) Constructing wrapper function "lagzo"... x,w = lagzo(n) Constructing wrapper function "legzo"... x,w = legzo(n) Constructing wrapper function "pbdv"... dv,dp,pdf,pdd = pbdv(v,x) Constructing wrapper function "cerzo"... zo = cerzo(nt) Constructing wrapper function "lamn"... nm,bl,dl = lamn(n,x) Constructing wrapper function "clpn"... cpn,cpd = clpn(n,z) Constructing wrapper function "lqmns"... qm,qd = lqmns(m,n,x) Constructing wrapper function "chgm"... hg = chgm(a,b,x) Constructing wrapper function "lpmn"... pm,pd = lpmn(m,n,x) Constructing wrapper function "fcszo"... zo = fcszo(kf,nt) Constructing wrapper function "aswfb"... s1f,s1d = aswfb(m,n,c,x,kd,cv) Constructing wrapper function "lqna"... qn,qd = lqna(n,x) Constructing wrapper function "cpbdn"... cpb,cpd = cpbdn(n,z) Constructing wrapper function "lpn"... pn,pd = lpn(n,x) Constructing wrapper function "fcoef"... fc = fcoef(kd,m,q,a) Constructing wrapper function "rcty"... nm,ry,dy = rcty(n,x) Constructing wrapper function "lpni"... pn,pd,pl = lpni(n,x) Constructing wrapper function "cyzo"... zo,zv = cyzo(nt,kf,kc) Constructing wrapper function "othpl"... pl,dpl = othpl(kf,n,x) Constructing wrapper function "klvnzo"... zo = klvnzo(nt,kd) Constructing wrapper function "jyzo"... rj0,rj1,ry0,ry1 = jyzo(n,nt) Constructing wrapper function "rctj"... nm,rj,dj = rctj(n,x) Constructing wrapper function "herzo"... x,w = herzo(n) Constructing wrapper function "pbvv"... vv,vp,pvf,pvd = pbvv(v,x) Constructing wrapper function "segv"... cv,eg = segv(m,n,c,kd) Wrote C/API module "specfun" to file "build/src.linux-ppc64le-2.7/scipy/special/specfunmodule.c" adding 'build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/special/fortranobject.c' to sources. adding 'build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/special' to include_dirs. creating build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/special copying /usr/lib64/python2.7/site-packages/numpy/f2py/src/fortranobject.c -> build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/special copying /usr/lib64/python2.7/site-packages/numpy/f2py/src/fortranobject.h -> build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/special building extension "scipy.special._ufuncs" sources conv_template:> build/src.linux-ppc64le-2.7/scipy/special/_logit.c building extension "scipy.special._ufuncs_cxx" sources building extension "scipy.special._ellip_harm_2" sources building extension "scipy.special.cython_special" sources building extension "scipy.special._comb" sources building extension "scipy.special._test_round" sources building extension "scipy.stats.statlib" sources creating build/src.linux-ppc64le-2.7/scipy/stats f2py options: ['--no-wrap-functions'] f2py: scipy/stats/statlib.pyf Reading fortran codes... Reading file 'scipy/stats/statlib.pyf' (format:free) Post-processing... Block: statlib Block: swilk Block: gscale Block: prho Post-processing (stage 2)... Building modules... Building module "statlib"... Constructing wrapper function "swilk"... a,w,pw,ifault = swilk(x,a,[init,n1]) Constructing wrapper function "gscale"... astart,a1,ifault = gscale(test,other) Constructing wrapper function "prho"... ifault = prho(n,is) Wrote C/API module "statlib" to file "build/src.linux-ppc64le-2.7/scipy/stats/statlibmodule.c" adding 'build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/stats/fortranobject.c' to sources. adding 'build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/stats' to include_dirs. creating build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/stats copying /usr/lib64/python2.7/site-packages/numpy/f2py/src/fortranobject.c -> build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/stats copying /usr/lib64/python2.7/site-packages/numpy/f2py/src/fortranobject.h -> build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/stats building extension "scipy.stats._stats" sources building extension "scipy.stats.mvn" sources f2py options: [] f2py: scipy/stats/mvn.pyf Reading fortran codes... Reading file 'scipy/stats/mvn.pyf' (format:free) Post-processing... Block: mvn Block: mvnun Block: mvndst Post-processing (stage 2)... Building modules... Building module "mvn"... Constructing wrapper function "mvnun"... value,inform = mvnun(lower,upper,means,covar,[maxpts,abseps,releps]) Constructing wrapper function "mvndst"... error,value,inform = mvndst(lower,upper,infin,correl,[maxpts,abseps,releps]) Constructing COMMON block support for "dkblck"... ivls Wrote C/API module "mvn" to file "build/src.linux-ppc64le-2.7/scipy/stats/mvnmodule.c" Fortran 77 wrappers are saved to "build/src.linux-ppc64le-2.7/scipy/stats/mvn-f2pywrappers.f" adding 'build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/stats/fortranobject.c' to sources. adding 'build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/stats' to include_dirs. adding 'build/src.linux-ppc64le-2.7/scipy/stats/mvn-f2pywrappers.f' to sources. building extension "scipy.ndimage._nd_image" sources building extension "scipy.ndimage._ni_label" sources building extension "scipy.ndimage._ctest" sources building extension "scipy.ndimage._ctest_oldapi" sources building extension "scipy.ndimage._cytest" sources building extension "scipy._lib._ccallback_c" sources building extension "scipy._lib._test_ccallback" sources building extension "scipy._lib._fpumode" sources building extension "scipy._lib.messagestream" sources creating build/src.linux-ppc64le-2.7/scipy/_lib customize Gnu95FCompiler Found executable /usr/bin/gfortran customize Gnu95FCompiler using config C compiler: gcc -pthread -fno-strict-aliasing -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -D_GNU_SOURCE -fPIC -fwrapv -DNDEBUG -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -D_GNU_SOURCE -fPIC -fwrapv -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -fPIC compile options: '-I/usr/include/python2.7 -c' gcc: _configtest.c gcc -pthread _configtest.o -o _configtest success! removing: _configtest.c _configtest.o _configtest building data_files sources build_src: building npy-pkg config files running build_py creating build/lib.linux-ppc64le-2.7 creating build/lib.linux-ppc64le-2.7/scipy copying scipy/__init__.py -> build/lib.linux-ppc64le-2.7/scipy copying scipy/conftest.py -> build/lib.linux-ppc64le-2.7/scipy copying scipy/setup.py -> build/lib.linux-ppc64le-2.7/scipy copying scipy/_distributor_init.py -> build/lib.linux-ppc64le-2.7/scipy copying scipy/version.py -> build/lib.linux-ppc64le-2.7/scipy copying build/src.linux-ppc64le-2.7/scipy/__config__.py -> build/lib.linux-ppc64le-2.7/scipy creating build/lib.linux-ppc64le-2.7/scipy/cluster copying scipy/cluster/__init__.py -> build/lib.linux-ppc64le-2.7/scipy/cluster copying scipy/cluster/vq.py -> build/lib.linux-ppc64le-2.7/scipy/cluster copying scipy/cluster/hierarchy.py -> build/lib.linux-ppc64le-2.7/scipy/cluster copying scipy/cluster/setup.py -> build/lib.linux-ppc64le-2.7/scipy/cluster creating build/lib.linux-ppc64le-2.7/scipy/constants copying scipy/constants/constants.py -> build/lib.linux-ppc64le-2.7/scipy/constants copying scipy/constants/__init__.py -> build/lib.linux-ppc64le-2.7/scipy/constants copying scipy/constants/codata.py -> build/lib.linux-ppc64le-2.7/scipy/constants copying scipy/constants/setup.py -> build/lib.linux-ppc64le-2.7/scipy/constants creating build/lib.linux-ppc64le-2.7/scipy/fftpack copying scipy/fftpack/basic.py -> build/lib.linux-ppc64le-2.7/scipy/fftpack copying scipy/fftpack/__init__.py -> build/lib.linux-ppc64le-2.7/scipy/fftpack copying scipy/fftpack/realtransforms.py -> build/lib.linux-ppc64le-2.7/scipy/fftpack copying scipy/fftpack/pseudo_diffs.py -> build/lib.linux-ppc64le-2.7/scipy/fftpack copying scipy/fftpack/setup.py -> build/lib.linux-ppc64le-2.7/scipy/fftpack copying scipy/fftpack/helper.py -> build/lib.linux-ppc64le-2.7/scipy/fftpack creating build/lib.linux-ppc64le-2.7/scipy/integrate copying scipy/integrate/quadpack.py -> build/lib.linux-ppc64le-2.7/scipy/integrate copying scipy/integrate/quadrature.py -> build/lib.linux-ppc64le-2.7/scipy/integrate copying scipy/integrate/__init__.py -> build/lib.linux-ppc64le-2.7/scipy/integrate copying scipy/integrate/odepack.py -> build/lib.linux-ppc64le-2.7/scipy/integrate copying scipy/integrate/_bvp.py -> build/lib.linux-ppc64le-2.7/scipy/integrate copying scipy/integrate/_ode.py -> build/lib.linux-ppc64le-2.7/scipy/integrate copying scipy/integrate/setup.py -> build/lib.linux-ppc64le-2.7/scipy/integrate creating build/lib.linux-ppc64le-2.7/scipy/integrate/_ivp copying scipy/integrate/_ivp/bdf.py -> build/lib.linux-ppc64le-2.7/scipy/integrate/_ivp copying scipy/integrate/_ivp/rk.py -> build/lib.linux-ppc64le-2.7/scipy/integrate/_ivp copying scipy/integrate/_ivp/__init__.py -> build/lib.linux-ppc64le-2.7/scipy/integrate/_ivp copying scipy/integrate/_ivp/base.py -> build/lib.linux-ppc64le-2.7/scipy/integrate/_ivp copying scipy/integrate/_ivp/common.py -> build/lib.linux-ppc64le-2.7/scipy/integrate/_ivp copying scipy/integrate/_ivp/ivp.py -> build/lib.linux-ppc64le-2.7/scipy/integrate/_ivp copying scipy/integrate/_ivp/lsoda.py -> build/lib.linux-ppc64le-2.7/scipy/integrate/_ivp copying scipy/integrate/_ivp/radau.py -> build/lib.linux-ppc64le-2.7/scipy/integrate/_ivp creating build/lib.linux-ppc64le-2.7/scipy/interpolate copying scipy/interpolate/rbf.py -> build/lib.linux-ppc64le-2.7/scipy/interpolate copying scipy/interpolate/interpnd_info.py -> build/lib.linux-ppc64le-2.7/scipy/interpolate copying scipy/interpolate/ndgriddata.py -> build/lib.linux-ppc64le-2.7/scipy/interpolate copying scipy/interpolate/_fitpack_impl.py -> build/lib.linux-ppc64le-2.7/scipy/interpolate copying scipy/interpolate/__init__.py -> build/lib.linux-ppc64le-2.7/scipy/interpolate copying scipy/interpolate/interpolate_wrapper.py -> build/lib.linux-ppc64le-2.7/scipy/interpolate copying scipy/interpolate/_cubic.py -> build/lib.linux-ppc64le-2.7/scipy/interpolate copying scipy/interpolate/_bsplines.py -> build/lib.linux-ppc64le-2.7/scipy/interpolate copying scipy/interpolate/polyint.py -> build/lib.linux-ppc64le-2.7/scipy/interpolate copying scipy/interpolate/fitpack2.py -> build/lib.linux-ppc64le-2.7/scipy/interpolate copying scipy/interpolate/_pade.py -> build/lib.linux-ppc64le-2.7/scipy/interpolate copying scipy/interpolate/setup.py -> build/lib.linux-ppc64le-2.7/scipy/interpolate copying scipy/interpolate/interpolate.py -> build/lib.linux-ppc64le-2.7/scipy/interpolate copying scipy/interpolate/fitpack.py -> build/lib.linux-ppc64le-2.7/scipy/interpolate creating build/lib.linux-ppc64le-2.7/scipy/io copying scipy/io/idl.py -> build/lib.linux-ppc64le-2.7/scipy/io copying scipy/io/netcdf.py -> build/lib.linux-ppc64le-2.7/scipy/io copying scipy/io/mmio.py -> build/lib.linux-ppc64le-2.7/scipy/io copying scipy/io/__init__.py -> build/lib.linux-ppc64le-2.7/scipy/io copying scipy/io/wavfile.py -> build/lib.linux-ppc64le-2.7/scipy/io copying scipy/io/_fortran.py -> build/lib.linux-ppc64le-2.7/scipy/io copying scipy/io/setup.py -> build/lib.linux-ppc64le-2.7/scipy/io creating build/lib.linux-ppc64le-2.7/scipy/io/matlab copying scipy/io/matlab/mio.py -> build/lib.linux-ppc64le-2.7/scipy/io/matlab copying scipy/io/matlab/__init__.py -> build/lib.linux-ppc64le-2.7/scipy/io/matlab copying scipy/io/matlab/byteordercodes.py -> build/lib.linux-ppc64le-2.7/scipy/io/matlab copying scipy/io/matlab/mio5.py -> build/lib.linux-ppc64le-2.7/scipy/io/matlab copying scipy/io/matlab/mio5_params.py -> build/lib.linux-ppc64le-2.7/scipy/io/matlab copying scipy/io/matlab/mio4.py -> build/lib.linux-ppc64le-2.7/scipy/io/matlab copying scipy/io/matlab/setup.py -> build/lib.linux-ppc64le-2.7/scipy/io/matlab copying scipy/io/matlab/miobase.py -> build/lib.linux-ppc64le-2.7/scipy/io/matlab creating build/lib.linux-ppc64le-2.7/scipy/io/arff copying scipy/io/arff/__init__.py -> build/lib.linux-ppc64le-2.7/scipy/io/arff copying scipy/io/arff/setup.py -> build/lib.linux-ppc64le-2.7/scipy/io/arff copying scipy/io/arff/arffread.py -> build/lib.linux-ppc64le-2.7/scipy/io/arff creating build/lib.linux-ppc64le-2.7/scipy/io/harwell_boeing copying scipy/io/harwell_boeing/_fortran_format_parser.py -> build/lib.linux-ppc64le-2.7/scipy/io/harwell_boeing copying scipy/io/harwell_boeing/__init__.py -> build/lib.linux-ppc64le-2.7/scipy/io/harwell_boeing copying scipy/io/harwell_boeing/setup.py -> build/lib.linux-ppc64le-2.7/scipy/io/harwell_boeing copying scipy/io/harwell_boeing/hb.py -> build/lib.linux-ppc64le-2.7/scipy/io/harwell_boeing creating build/lib.linux-ppc64le-2.7/scipy/linalg copying scipy/linalg/basic.py -> build/lib.linux-ppc64le-2.7/scipy/linalg copying scipy/linalg/misc.py -> build/lib.linux-ppc64le-2.7/scipy/linalg copying scipy/linalg/_expm_frechet.py -> build/lib.linux-ppc64le-2.7/scipy/linalg copying scipy/linalg/linalg_version.py -> build/lib.linux-ppc64le-2.7/scipy/linalg copying scipy/linalg/_decomp_qz.py -> build/lib.linux-ppc64le-2.7/scipy/linalg copying scipy/linalg/decomp_schur.py -> build/lib.linux-ppc64le-2.7/scipy/linalg copying scipy/linalg/_procrustes.py -> build/lib.linux-ppc64le-2.7/scipy/linalg copying scipy/linalg/lapack.py -> build/lib.linux-ppc64le-2.7/scipy/linalg copying scipy/linalg/decomp_lu.py -> build/lib.linux-ppc64le-2.7/scipy/linalg copying scipy/linalg/blas.py -> build/lib.linux-ppc64le-2.7/scipy/linalg copying scipy/linalg/matfuncs.py -> build/lib.linux-ppc64le-2.7/scipy/linalg copying scipy/linalg/__init__.py -> build/lib.linux-ppc64le-2.7/scipy/linalg copying scipy/linalg/_matfuncs_sqrtm.py -> build/lib.linux-ppc64le-2.7/scipy/linalg copying scipy/linalg/_solvers.py -> build/lib.linux-ppc64le-2.7/scipy/linalg copying scipy/linalg/decomp.py -> build/lib.linux-ppc64le-2.7/scipy/linalg copying scipy/linalg/_testutils.py -> build/lib.linux-ppc64le-2.7/scipy/linalg copying scipy/linalg/_decomp_polar.py -> build/lib.linux-ppc64le-2.7/scipy/linalg copying scipy/linalg/_cython_signature_generator.py -> build/lib.linux-ppc64le-2.7/scipy/linalg copying scipy/linalg/special_matrices.py -> build/lib.linux-ppc64le-2.7/scipy/linalg copying scipy/linalg/flinalg.py -> build/lib.linux-ppc64le-2.7/scipy/linalg copying scipy/linalg/_matfuncs_inv_ssq.py -> build/lib.linux-ppc64le-2.7/scipy/linalg copying scipy/linalg/setup.py -> build/lib.linux-ppc64le-2.7/scipy/linalg copying scipy/linalg/decomp_qr.py -> build/lib.linux-ppc64le-2.7/scipy/linalg copying scipy/linalg/_sketches.py -> build/lib.linux-ppc64le-2.7/scipy/linalg copying scipy/linalg/interpolative.py -> build/lib.linux-ppc64le-2.7/scipy/linalg copying scipy/linalg/_generate_pyx.py -> build/lib.linux-ppc64le-2.7/scipy/linalg copying scipy/linalg/decomp_cholesky.py -> build/lib.linux-ppc64le-2.7/scipy/linalg copying scipy/linalg/decomp_svd.py -> build/lib.linux-ppc64le-2.7/scipy/linalg copying scipy/linalg/_interpolative_backend.py -> build/lib.linux-ppc64le-2.7/scipy/linalg creating build/lib.linux-ppc64le-2.7/scipy/misc copying scipy/misc/__init__.py -> build/lib.linux-ppc64le-2.7/scipy/misc copying scipy/misc/pilutil.py -> build/lib.linux-ppc64le-2.7/scipy/misc copying scipy/misc/doccer.py -> build/lib.linux-ppc64le-2.7/scipy/misc copying scipy/misc/setup.py -> build/lib.linux-ppc64le-2.7/scipy/misc copying scipy/misc/common.py -> build/lib.linux-ppc64le-2.7/scipy/misc creating build/lib.linux-ppc64le-2.7/scipy/odr copying scipy/odr/add_newdocs.py -> build/lib.linux-ppc64le-2.7/scipy/odr copying scipy/odr/models.py -> build/lib.linux-ppc64le-2.7/scipy/odr copying scipy/odr/__init__.py -> build/lib.linux-ppc64le-2.7/scipy/odr copying scipy/odr/odrpack.py -> build/lib.linux-ppc64le-2.7/scipy/odr copying scipy/odr/setup.py -> build/lib.linux-ppc64le-2.7/scipy/odr creating build/lib.linux-ppc64le-2.7/scipy/optimize copying scipy/optimize/lbfgsb.py -> build/lib.linux-ppc64le-2.7/scipy/optimize copying scipy/optimize/nnls.py -> build/lib.linux-ppc64le-2.7/scipy/optimize copying scipy/optimize/_trustregion_dogleg.py -> build/lib.linux-ppc64le-2.7/scipy/optimize copying scipy/optimize/cobyla.py -> build/lib.linux-ppc64le-2.7/scipy/optimize copying scipy/optimize/_differentialevolution.py -> build/lib.linux-ppc64le-2.7/scipy/optimize copying scipy/optimize/_hungarian.py -> build/lib.linux-ppc64le-2.7/scipy/optimize copying scipy/optimize/_numdiff.py -> build/lib.linux-ppc64le-2.7/scipy/optimize copying scipy/optimize/__init__.py -> build/lib.linux-ppc64le-2.7/scipy/optimize copying scipy/optimize/_linprog.py -> build/lib.linux-ppc64le-2.7/scipy/optimize copying scipy/optimize/_trustregion_exact.py -> build/lib.linux-ppc64le-2.7/scipy/optimize copying scipy/optimize/tnc.py -> build/lib.linux-ppc64le-2.7/scipy/optimize copying scipy/optimize/nonlin.py -> build/lib.linux-ppc64le-2.7/scipy/optimize copying scipy/optimize/_linprog_ip.py -> build/lib.linux-ppc64le-2.7/scipy/optimize copying scipy/optimize/slsqp.py -> build/lib.linux-ppc64le-2.7/scipy/optimize copying scipy/optimize/_minimize.py -> build/lib.linux-ppc64le-2.7/scipy/optimize copying scipy/optimize/_trustregion_krylov.py -> build/lib.linux-ppc64le-2.7/scipy/optimize copying scipy/optimize/_tstutils.py -> build/lib.linux-ppc64le-2.7/scipy/optimize copying scipy/optimize/_root.py -> build/lib.linux-ppc64le-2.7/scipy/optimize copying scipy/optimize/setup.py -> build/lib.linux-ppc64le-2.7/scipy/optimize copying scipy/optimize/_remove_redundancy.py -> build/lib.linux-ppc64le-2.7/scipy/optimize copying scipy/optimize/_spectral.py -> build/lib.linux-ppc64le-2.7/scipy/optimize copying scipy/optimize/_basinhopping.py -> build/lib.linux-ppc64le-2.7/scipy/optimize copying scipy/optimize/minpack.py -> build/lib.linux-ppc64le-2.7/scipy/optimize copying scipy/optimize/_trustregion.py -> build/lib.linux-ppc64le-2.7/scipy/optimize copying scipy/optimize/optimize.py -> build/lib.linux-ppc64le-2.7/scipy/optimize copying scipy/optimize/zeros.py -> build/lib.linux-ppc64le-2.7/scipy/optimize copying scipy/optimize/_trustregion_ncg.py -> build/lib.linux-ppc64le-2.7/scipy/optimize copying scipy/optimize/linesearch.py -> build/lib.linux-ppc64le-2.7/scipy/optimize creating build/lib.linux-ppc64le-2.7/scipy/optimize/_lsq copying scipy/optimize/_lsq/trf_linear.py -> build/lib.linux-ppc64le-2.7/scipy/optimize/_lsq copying scipy/optimize/_lsq/least_squares.py -> build/lib.linux-ppc64le-2.7/scipy/optimize/_lsq copying scipy/optimize/_lsq/dogbox.py -> build/lib.linux-ppc64le-2.7/scipy/optimize/_lsq copying scipy/optimize/_lsq/__init__.py -> build/lib.linux-ppc64le-2.7/scipy/optimize/_lsq copying scipy/optimize/_lsq/lsq_linear.py -> build/lib.linux-ppc64le-2.7/scipy/optimize/_lsq copying scipy/optimize/_lsq/trf.py -> build/lib.linux-ppc64le-2.7/scipy/optimize/_lsq copying scipy/optimize/_lsq/bvls.py -> build/lib.linux-ppc64le-2.7/scipy/optimize/_lsq copying scipy/optimize/_lsq/setup.py -> build/lib.linux-ppc64le-2.7/scipy/optimize/_lsq copying scipy/optimize/_lsq/common.py -> build/lib.linux-ppc64le-2.7/scipy/optimize/_lsq creating build/lib.linux-ppc64le-2.7/scipy/optimize/_trlib copying scipy/optimize/_trlib/__init__.py -> build/lib.linux-ppc64le-2.7/scipy/optimize/_trlib copying scipy/optimize/_trlib/setup.py -> build/lib.linux-ppc64le-2.7/scipy/optimize/_trlib creating build/lib.linux-ppc64le-2.7/scipy/signal copying scipy/signal/windows.py -> build/lib.linux-ppc64le-2.7/scipy/signal copying scipy/signal/wavelets.py -> build/lib.linux-ppc64le-2.7/scipy/signal copying scipy/signal/_arraytools.py -> build/lib.linux-ppc64le-2.7/scipy/signal copying scipy/signal/ltisys.py -> build/lib.linux-ppc64le-2.7/scipy/signal copying scipy/signal/spectral.py -> build/lib.linux-ppc64le-2.7/scipy/signal copying scipy/signal/_peak_finding.py -> build/lib.linux-ppc64le-2.7/scipy/signal copying scipy/signal/filter_design.py -> build/lib.linux-ppc64le-2.7/scipy/signal copying scipy/signal/__init__.py -> build/lib.linux-ppc64le-2.7/scipy/signal copying scipy/signal/waveforms.py -> build/lib.linux-ppc64le-2.7/scipy/signal copying scipy/signal/fir_filter_design.py -> build/lib.linux-ppc64le-2.7/scipy/signal copying scipy/signal/lti_conversion.py -> build/lib.linux-ppc64le-2.7/scipy/signal copying scipy/signal/_max_len_seq.py -> build/lib.linux-ppc64le-2.7/scipy/signal copying scipy/signal/setup.py -> build/lib.linux-ppc64le-2.7/scipy/signal copying scipy/signal/bsplines.py -> build/lib.linux-ppc64le-2.7/scipy/signal copying scipy/signal/_upfirdn.py -> build/lib.linux-ppc64le-2.7/scipy/signal copying scipy/signal/_savitzky_golay.py -> build/lib.linux-ppc64le-2.7/scipy/signal copying scipy/signal/signaltools.py -> build/lib.linux-ppc64le-2.7/scipy/signal creating build/lib.linux-ppc64le-2.7/scipy/sparse copying scipy/sparse/coo.py -> build/lib.linux-ppc64le-2.7/scipy/sparse copying scipy/sparse/compressed.py -> build/lib.linux-ppc64le-2.7/scipy/sparse copying scipy/sparse/csc.py -> build/lib.linux-ppc64le-2.7/scipy/sparse copying scipy/sparse/sputils.py -> build/lib.linux-ppc64le-2.7/scipy/sparse copying scipy/sparse/spfuncs.py -> build/lib.linux-ppc64le-2.7/scipy/sparse copying scipy/sparse/_matrix_io.py -> build/lib.linux-ppc64le-2.7/scipy/sparse copying scipy/sparse/sparsetools.py -> build/lib.linux-ppc64le-2.7/scipy/sparse copying scipy/sparse/construct.py -> build/lib.linux-ppc64le-2.7/scipy/sparse copying scipy/sparse/data.py -> build/lib.linux-ppc64le-2.7/scipy/sparse copying scipy/sparse/__init__.py -> build/lib.linux-ppc64le-2.7/scipy/sparse copying scipy/sparse/extract.py -> build/lib.linux-ppc64le-2.7/scipy/sparse copying scipy/sparse/dok.py -> build/lib.linux-ppc64le-2.7/scipy/sparse copying scipy/sparse/csr.py -> build/lib.linux-ppc64le-2.7/scipy/sparse copying scipy/sparse/generate_sparsetools.py -> build/lib.linux-ppc64le-2.7/scipy/sparse copying scipy/sparse/lil.py -> build/lib.linux-ppc64le-2.7/scipy/sparse copying scipy/sparse/bsr.py -> build/lib.linux-ppc64le-2.7/scipy/sparse copying scipy/sparse/base.py -> build/lib.linux-ppc64le-2.7/scipy/sparse copying scipy/sparse/dia.py -> build/lib.linux-ppc64le-2.7/scipy/sparse copying scipy/sparse/setup.py -> build/lib.linux-ppc64le-2.7/scipy/sparse creating build/lib.linux-ppc64le-2.7/scipy/sparse/linalg copying scipy/sparse/linalg/_norm.py -> build/lib.linux-ppc64le-2.7/scipy/sparse/linalg copying scipy/sparse/linalg/matfuncs.py -> build/lib.linux-ppc64le-2.7/scipy/sparse/linalg copying scipy/sparse/linalg/__init__.py -> build/lib.linux-ppc64le-2.7/scipy/sparse/linalg copying scipy/sparse/linalg/_expm_multiply.py -> build/lib.linux-ppc64le-2.7/scipy/sparse/linalg copying scipy/sparse/linalg/_onenormest.py -> build/lib.linux-ppc64le-2.7/scipy/sparse/linalg copying scipy/sparse/linalg/setup.py -> build/lib.linux-ppc64le-2.7/scipy/sparse/linalg copying scipy/sparse/linalg/interface.py -> build/lib.linux-ppc64le-2.7/scipy/sparse/linalg creating build/lib.linux-ppc64le-2.7/scipy/sparse/linalg/isolve copying scipy/sparse/linalg/isolve/lgmres.py -> build/lib.linux-ppc64le-2.7/scipy/sparse/linalg/isolve copying scipy/sparse/linalg/isolve/iterative.py -> build/lib.linux-ppc64le-2.7/scipy/sparse/linalg/isolve copying scipy/sparse/linalg/isolve/minres.py -> build/lib.linux-ppc64le-2.7/scipy/sparse/linalg/isolve copying scipy/sparse/linalg/isolve/utils.py -> build/lib.linux-ppc64le-2.7/scipy/sparse/linalg/isolve copying scipy/sparse/linalg/isolve/__init__.py -> build/lib.linux-ppc64le-2.7/scipy/sparse/linalg/isolve copying scipy/sparse/linalg/isolve/lsqr.py -> build/lib.linux-ppc64le-2.7/scipy/sparse/linalg/isolve copying scipy/sparse/linalg/isolve/lsmr.py -> build/lib.linux-ppc64le-2.7/scipy/sparse/linalg/isolve copying scipy/sparse/linalg/isolve/setup.py -> build/lib.linux-ppc64le-2.7/scipy/sparse/linalg/isolve copying scipy/sparse/linalg/isolve/_gcrotmk.py -> build/lib.linux-ppc64le-2.7/scipy/sparse/linalg/isolve creating build/lib.linux-ppc64le-2.7/scipy/sparse/linalg/dsolve copying scipy/sparse/linalg/dsolve/linsolve.py -> build/lib.linux-ppc64le-2.7/scipy/sparse/linalg/dsolve copying scipy/sparse/linalg/dsolve/_add_newdocs.py -> build/lib.linux-ppc64le-2.7/scipy/sparse/linalg/dsolve copying scipy/sparse/linalg/dsolve/__init__.py -> build/lib.linux-ppc64le-2.7/scipy/sparse/linalg/dsolve copying scipy/sparse/linalg/dsolve/setup.py -> build/lib.linux-ppc64le-2.7/scipy/sparse/linalg/dsolve creating build/lib.linux-ppc64le-2.7/scipy/sparse/linalg/eigen copying scipy/sparse/linalg/eigen/__init__.py -> build/lib.linux-ppc64le-2.7/scipy/sparse/linalg/eigen copying scipy/sparse/linalg/eigen/setup.py -> build/lib.linux-ppc64le-2.7/scipy/sparse/linalg/eigen creating build/lib.linux-ppc64le-2.7/scipy/sparse/linalg/eigen/arpack copying scipy/sparse/linalg/eigen/arpack/__init__.py -> build/lib.linux-ppc64le-2.7/scipy/sparse/linalg/eigen/arpack copying scipy/sparse/linalg/eigen/arpack/setup.py -> build/lib.linux-ppc64le-2.7/scipy/sparse/linalg/eigen/arpack copying scipy/sparse/linalg/eigen/arpack/arpack.py -> build/lib.linux-ppc64le-2.7/scipy/sparse/linalg/eigen/arpack creating build/lib.linux-ppc64le-2.7/scipy/sparse/linalg/eigen/lobpcg copying scipy/sparse/linalg/eigen/lobpcg/__init__.py -> build/lib.linux-ppc64le-2.7/scipy/sparse/linalg/eigen/lobpcg copying scipy/sparse/linalg/eigen/lobpcg/setup.py -> build/lib.linux-ppc64le-2.7/scipy/sparse/linalg/eigen/lobpcg copying scipy/sparse/linalg/eigen/lobpcg/lobpcg.py -> build/lib.linux-ppc64le-2.7/scipy/sparse/linalg/eigen/lobpcg creating build/lib.linux-ppc64le-2.7/scipy/sparse/csgraph copying scipy/sparse/csgraph/_laplacian.py -> build/lib.linux-ppc64le-2.7/scipy/sparse/csgraph copying scipy/sparse/csgraph/__init__.py -> build/lib.linux-ppc64le-2.7/scipy/sparse/csgraph copying scipy/sparse/csgraph/setup.py -> build/lib.linux-ppc64le-2.7/scipy/sparse/csgraph copying scipy/sparse/csgraph/_validation.py -> build/lib.linux-ppc64le-2.7/scipy/sparse/csgraph creating build/lib.linux-ppc64le-2.7/scipy/spatial copying scipy/spatial/_procrustes.py -> build/lib.linux-ppc64le-2.7/scipy/spatial copying scipy/spatial/kdtree.py -> build/lib.linux-ppc64le-2.7/scipy/spatial copying scipy/spatial/distance.py -> build/lib.linux-ppc64le-2.7/scipy/spatial copying scipy/spatial/__init__.py -> build/lib.linux-ppc64le-2.7/scipy/spatial copying scipy/spatial/_plotutils.py -> build/lib.linux-ppc64le-2.7/scipy/spatial copying scipy/spatial/_spherical_voronoi.py -> build/lib.linux-ppc64le-2.7/scipy/spatial copying scipy/spatial/setup.py -> build/lib.linux-ppc64le-2.7/scipy/spatial creating build/lib.linux-ppc64le-2.7/scipy/special copying scipy/special/_mptestutils.py -> build/lib.linux-ppc64le-2.7/scipy/special copying scipy/special/basic.py -> build/lib.linux-ppc64le-2.7/scipy/special copying scipy/special/add_newdocs.py -> build/lib.linux-ppc64le-2.7/scipy/special copying scipy/special/lambertw.py -> build/lib.linux-ppc64le-2.7/scipy/special copying scipy/special/__init__.py -> build/lib.linux-ppc64le-2.7/scipy/special copying scipy/special/_spherical_bessel.py -> build/lib.linux-ppc64le-2.7/scipy/special copying scipy/special/_logsumexp.py -> build/lib.linux-ppc64le-2.7/scipy/special copying scipy/special/_testutils.py -> build/lib.linux-ppc64le-2.7/scipy/special copying scipy/special/orthogonal.py -> build/lib.linux-ppc64le-2.7/scipy/special copying scipy/special/setup.py -> build/lib.linux-ppc64le-2.7/scipy/special copying scipy/special/spfun_stats.py -> build/lib.linux-ppc64le-2.7/scipy/special copying scipy/special/_generate_pyx.py -> build/lib.linux-ppc64le-2.7/scipy/special copying scipy/special/sf_error.py -> build/lib.linux-ppc64le-2.7/scipy/special copying scipy/special/_ellip_harm.py -> build/lib.linux-ppc64le-2.7/scipy/special creating build/lib.linux-ppc64le-2.7/scipy/special/_precompute copying scipy/special/_precompute/gammainc_data.py -> build/lib.linux-ppc64le-2.7/scipy/special/_precompute copying scipy/special/_precompute/utils.py -> build/lib.linux-ppc64le-2.7/scipy/special/_precompute copying scipy/special/_precompute/__init__.py -> build/lib.linux-ppc64le-2.7/scipy/special/_precompute copying scipy/special/_precompute/expn_asy.py -> build/lib.linux-ppc64le-2.7/scipy/special/_precompute copying scipy/special/_precompute/loggamma.py -> build/lib.linux-ppc64le-2.7/scipy/special/_precompute copying scipy/special/_precompute/setup.py -> build/lib.linux-ppc64le-2.7/scipy/special/_precompute copying scipy/special/_precompute/gammainc_asy.py -> build/lib.linux-ppc64le-2.7/scipy/special/_precompute creating build/lib.linux-ppc64le-2.7/scipy/stats copying scipy/stats/contingency.py -> build/lib.linux-ppc64le-2.7/scipy/stats copying scipy/stats/mstats.py -> build/lib.linux-ppc64le-2.7/scipy/stats copying scipy/stats/_multivariate.py -> build/lib.linux-ppc64le-2.7/scipy/stats copying scipy/stats/mstats_basic.py -> build/lib.linux-ppc64le-2.7/scipy/stats copying scipy/stats/mstats_extras.py -> build/lib.linux-ppc64le-2.7/scipy/stats copying scipy/stats/morestats.py -> build/lib.linux-ppc64le-2.7/scipy/stats copying scipy/stats/_tukeylambda_stats.py -> build/lib.linux-ppc64le-2.7/scipy/stats copying scipy/stats/__init__.py -> build/lib.linux-ppc64le-2.7/scipy/stats copying scipy/stats/vonmises.py -> build/lib.linux-ppc64le-2.7/scipy/stats copying scipy/stats/distributions.py -> build/lib.linux-ppc64le-2.7/scipy/stats copying scipy/stats/_discrete_distns.py -> build/lib.linux-ppc64le-2.7/scipy/stats copying scipy/stats/_stats_mstats_common.py -> build/lib.linux-ppc64le-2.7/scipy/stats copying scipy/stats/_distr_params.py -> build/lib.linux-ppc64le-2.7/scipy/stats copying scipy/stats/_constants.py -> build/lib.linux-ppc64le-2.7/scipy/stats copying scipy/stats/setup.py -> build/lib.linux-ppc64le-2.7/scipy/stats copying scipy/stats/kde.py -> build/lib.linux-ppc64le-2.7/scipy/stats copying scipy/stats/_continuous_distns.py -> build/lib.linux-ppc64le-2.7/scipy/stats copying scipy/stats/_binned_statistic.py -> build/lib.linux-ppc64le-2.7/scipy/stats copying scipy/stats/stats.py -> build/lib.linux-ppc64le-2.7/scipy/stats copying scipy/stats/_distn_infrastructure.py -> build/lib.linux-ppc64le-2.7/scipy/stats creating build/lib.linux-ppc64le-2.7/scipy/ndimage copying scipy/ndimage/_ni_support.py -> build/lib.linux-ppc64le-2.7/scipy/ndimage copying scipy/ndimage/fourier.py -> build/lib.linux-ppc64le-2.7/scipy/ndimage copying scipy/ndimage/measurements.py -> build/lib.linux-ppc64le-2.7/scipy/ndimage copying scipy/ndimage/filters.py -> build/lib.linux-ppc64le-2.7/scipy/ndimage copying scipy/ndimage/morphology.py -> build/lib.linux-ppc64le-2.7/scipy/ndimage copying scipy/ndimage/__init__.py -> build/lib.linux-ppc64le-2.7/scipy/ndimage copying scipy/ndimage/io.py -> build/lib.linux-ppc64le-2.7/scipy/ndimage copying scipy/ndimage/setup.py -> build/lib.linux-ppc64le-2.7/scipy/ndimage copying scipy/ndimage/interpolation.py -> build/lib.linux-ppc64le-2.7/scipy/ndimage creating build/lib.linux-ppc64le-2.7/scipy/_build_utils copying scipy/_build_utils/__init__.py -> build/lib.linux-ppc64le-2.7/scipy/_build_utils copying scipy/_build_utils/_fortran.py -> build/lib.linux-ppc64le-2.7/scipy/_build_utils creating build/lib.linux-ppc64le-2.7/scipy/_lib copying scipy/_lib/_tmpdirs.py -> build/lib.linux-ppc64le-2.7/scipy/_lib copying scipy/_lib/_numpy_compat.py -> build/lib.linux-ppc64le-2.7/scipy/_lib copying scipy/_lib/_version.py -> build/lib.linux-ppc64le-2.7/scipy/_lib copying scipy/_lib/__init__.py -> build/lib.linux-ppc64le-2.7/scipy/_lib copying scipy/_lib/_util.py -> build/lib.linux-ppc64le-2.7/scipy/_lib copying scipy/_lib/_threadsafety.py -> build/lib.linux-ppc64le-2.7/scipy/_lib copying scipy/_lib/_testutils.py -> build/lib.linux-ppc64le-2.7/scipy/_lib copying scipy/_lib/decorator.py -> build/lib.linux-ppc64le-2.7/scipy/_lib copying scipy/_lib/_ccallback.py -> build/lib.linux-ppc64le-2.7/scipy/_lib copying scipy/_lib/setup.py -> build/lib.linux-ppc64le-2.7/scipy/_lib copying scipy/_lib/_gcutils.py -> build/lib.linux-ppc64le-2.7/scipy/_lib running build_clib customize UnixCCompiler customize UnixCCompiler using build_clib customize Gnu95FCompiler customize Gnu95FCompiler using build_clib building 'dfftpack' library compiling Fortran sources Fortran f77 compiler: /usr/bin/gfortran -Wall -g -ffixed-form -fno-second-underscore -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -fPIC -cpp -O3 -funroll-loops Fortran f90 compiler: /usr/bin/gfortran -Wall -g -fno-second-underscore -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -fPIC -cpp -O3 -funroll-loops Fortran fix compiler: /usr/bin/gfortran -Wall -g -ffixed-form -fno-second-underscore -Wall -g -fno-second-underscore -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -fPIC -cpp -O3 -funroll-loops creating build/temp.linux-ppc64le-2.7 creating build/temp.linux-ppc64le-2.7/scipy creating build/temp.linux-ppc64le-2.7/scipy/fftpack creating build/temp.linux-ppc64le-2.7/scipy/fftpack/src creating build/temp.linux-ppc64le-2.7/scipy/fftpack/src/dfftpack compile options: '-I/usr/lib64/python2.7/site-packages/numpy/core/include -c' gfortran:f77: scipy/fftpack/src/dfftpack/zfftf1.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran scipy/fftpack/src/dfftpack/zfftf1.f:294:43: scipy/fftpack/src/dfftpack/zfftf1.f:277:72: DO 103 I=2,IDO,2 2 scipy/fftpack/src/dfftpack/zfftf1.f:294:43: CH(I-1,K,2) = WA1(I-1)*CR2+WA1(I)*CI2 1 Warning: Array reference at (1) out of bounds (2 > 1) in loop beginning at (2) scipy/fftpack/src/dfftpack/zfftf1.f:295:41: scipy/fftpack/src/dfftpack/zfftf1.f:277:72: DO 103 I=2,IDO,2 2 scipy/fftpack/src/dfftpack/zfftf1.f:295:41: CH(I,K,2) = WA1(I-1)*CI2-WA1(I)*CR2 1 Warning: Array reference at (1) out of bounds (2 > 1) in loop beginning at (2) scipy/fftpack/src/dfftpack/zfftf1.f:296:43: scipy/fftpack/src/dfftpack/zfftf1.f:277:72: DO 103 I=2,IDO,2 2 scipy/fftpack/src/dfftpack/zfftf1.f:296:43: CH(I-1,K,3) = WA2(I-1)*CR3+WA2(I)*CI3 1 Warning: Array reference at (1) out of bounds (2 > 1) in loop beginning at (2) scipy/fftpack/src/dfftpack/zfftf1.f:297:41: scipy/fftpack/src/dfftpack/zfftf1.f:277:72: DO 103 I=2,IDO,2 2 scipy/fftpack/src/dfftpack/zfftf1.f:297:41: CH(I,K,3) = WA2(I-1)*CI3-WA2(I)*CR3 1 Warning: Array reference at (1) out of bounds (2 > 1) in loop beginning at (2) scipy/fftpack/src/dfftpack/zfftf1.f:298:43: scipy/fftpack/src/dfftpack/zfftf1.f:277:72: DO 103 I=2,IDO,2 2 scipy/fftpack/src/dfftpack/zfftf1.f:298:43: CH(I-1,K,4) = WA3(I-1)*CR4+WA3(I)*CI4 1 Warning: Array reference at (1) out of bounds (2 > 1) in loop beginning at (2) scipy/fftpack/src/dfftpack/zfftf1.f:299:41: scipy/fftpack/src/dfftpack/zfftf1.f:277:72: DO 103 I=2,IDO,2 2 scipy/fftpack/src/dfftpack/zfftf1.f:299:41: CH(I,K,4) = WA3(I-1)*CI4-WA3(I)*CR4 1 Warning: Array reference at (1) out of bounds (2 > 1) in loop beginning at (2) scipy/fftpack/src/dfftpack/zfftf1.f:200:41: scipy/fftpack/src/dfftpack/zfftf1.f:195:72: DO 103 I=2,IDO,2 2 scipy/fftpack/src/dfftpack/zfftf1.f:200:41: CH(I,K,2) = WA1(I-1)*TI2-WA1(I)*TR2 1 Warning: Array reference at (1) out of bounds (2 > 1) in loop beginning at (2) scipy/fftpack/src/dfftpack/zfftf1.f:201:43: scipy/fftpack/src/dfftpack/zfftf1.f:195:72: DO 103 I=2,IDO,2 2 scipy/fftpack/src/dfftpack/zfftf1.f:201:43: CH(I-1,K,2) = WA1(I-1)*TR2+WA1(I)*TI2 1 Warning: Array reference at (1) out of bounds (2 > 1) in loop beginning at (2) scipy/fftpack/src/dfftpack/zfftf1.f:243:41: scipy/fftpack/src/dfftpack/zfftf1.f:230:72: DO 103 I=2,IDO,2 2 scipy/fftpack/src/dfftpack/zfftf1.f:243:41: CH(I,K,2) = WA1(I-1)*DI2-WA1(I)*DR2 1 Warning: Array reference at (1) out of bounds (2 > 1) in loop beginning at (2) scipy/fftpack/src/dfftpack/zfftf1.f:244:43: scipy/fftpack/src/dfftpack/zfftf1.f:230:72: DO 103 I=2,IDO,2 2 scipy/fftpack/src/dfftpack/zfftf1.f:244:43: CH(I-1,K,2) = WA1(I-1)*DR2+WA1(I)*DI2 1 Warning: Array reference at (1) out of bounds (2 > 1) in loop beginning at (2) scipy/fftpack/src/dfftpack/zfftf1.f:245:41: scipy/fftpack/src/dfftpack/zfftf1.f:230:72: DO 103 I=2,IDO,2 2 scipy/fftpack/src/dfftpack/zfftf1.f:245:41: CH(I,K,3) = WA2(I-1)*DI3-WA2(I)*DR3 1 Warning: Array reference at (1) out of bounds (2 > 1) in loop beginning at (2) scipy/fftpack/src/dfftpack/zfftf1.f:246:43: scipy/fftpack/src/dfftpack/zfftf1.f:230:72: DO 103 I=2,IDO,2 2 scipy/fftpack/src/dfftpack/zfftf1.f:246:43: CH(I-1,K,3) = WA2(I-1)*DR3+WA2(I)*DI3 1 Warning: Array reference at (1) out of bounds (2 > 1) in loop beginning at (2) scipy/fftpack/src/dfftpack/zfftf1.f:372:43: scipy/fftpack/src/dfftpack/zfftf1.f:345:72: DO 103 I=2,IDO,2 2 scipy/fftpack/src/dfftpack/zfftf1.f:372:43: CH(I-1,K,2) = WA1(I-1)*DR2+WA1(I)*DI2 1 Warning: Array reference at (1) out of bounds (2 > 1) in loop beginning at (2) scipy/fftpack/src/dfftpack/zfftf1.f:373:41: scipy/fftpack/src/dfftpack/zfftf1.f:345:72: DO 103 I=2,IDO,2 2 scipy/fftpack/src/dfftpack/zfftf1.f:373:41: CH(I,K,2) = WA1(I-1)*DI2-WA1(I)*DR2 1 Warning: Array reference at (1) out of bounds (2 > 1) in loop beginning at (2) scipy/fftpack/src/dfftpack/zfftf1.f:374:43: scipy/fftpack/src/dfftpack/zfftf1.f:345:72: DO 103 I=2,IDO,2 2 scipy/fftpack/src/dfftpack/zfftf1.f:374:43: CH(I-1,K,3) = WA2(I-1)*DR3+WA2(I)*DI3 1 Warning: Array reference at (1) out of bounds (2 > 1) in loop beginning at (2) scipy/fftpack/src/dfftpack/zfftf1.f:375:41: scipy/fftpack/src/dfftpack/zfftf1.f:345:72: DO 103 I=2,IDO,2 2 scipy/fftpack/src/dfftpack/zfftf1.f:375:41: CH(I,K,3) = WA2(I-1)*DI3-WA2(I)*DR3 1 Warning: Array reference at (1) out of bounds (2 > 1) in loop beginning at (2) scipy/fftpack/src/dfftpack/zfftf1.f:376:43: scipy/fftpack/src/dfftpack/zfftf1.f:345:72: DO 103 I=2,IDO,2 2 scipy/fftpack/src/dfftpack/zfftf1.f:376:43: CH(I-1,K,4) = WA3(I-1)*DR4+WA3(I)*DI4 1 Warning: Array reference at (1) out of bounds (2 > 1) in loop beginning at (2) scipy/fftpack/src/dfftpack/zfftf1.f:377:41: scipy/fftpack/src/dfftpack/zfftf1.f:345:72: DO 103 I=2,IDO,2 2 scipy/fftpack/src/dfftpack/zfftf1.f:377:41: CH(I,K,4) = WA3(I-1)*DI4-WA3(I)*DR4 1 Warning: Array reference at (1) out of bounds (2 > 1) in loop beginning at (2) scipy/fftpack/src/dfftpack/zfftf1.f:378:43: scipy/fftpack/src/dfftpack/zfftf1.f:345:72: DO 103 I=2,IDO,2 2 scipy/fftpack/src/dfftpack/zfftf1.f:378:43: CH(I-1,K,5) = WA4(I-1)*DR5+WA4(I)*DI5 1 Warning: Array reference at (1) out of bounds (2 > 1) in loop beginning at (2) scipy/fftpack/src/dfftpack/zfftf1.f:379:41: scipy/fftpack/src/dfftpack/zfftf1.f:345:72: DO 103 I=2,IDO,2 2 scipy/fftpack/src/dfftpack/zfftf1.f:379:41: CH(I,K,5) = WA4(I-1)*DI5-WA4(I)*DR5 1 Warning: Array reference at (1) out of bounds (2 > 1) in loop beginning at (2) gfortran:f77: scipy/fftpack/src/dfftpack/dfftb.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/fftpack/src/dfftpack/dcosqi.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/fftpack/src/dfftpack/dsinqf.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran scipy/fftpack/src/dfftpack/dsinqf.f:14:11: DO 102 K=2,N,2 2 X(K) = -X(K) 1 Warning: Array reference at (1) out of bounds (2 > 1) in loop beginning at (2) scipy/fftpack/src/dfftpack/dsinqf.f:14:19: DO 102 K=2,N,2 2 X(K) = -X(K) 1 Warning: Array reference at (1) out of bounds (2 > 1) in loop beginning at (2) gfortran:f77: scipy/fftpack/src/dfftpack/dsinti.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/fftpack/src/dfftpack/zffti1.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/fftpack/src/dfftpack/dffti.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/fftpack/src/dfftpack/dcosqf.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran scipy/fftpack/src/dfftpack/dcosqf.f:23:12: scipy/fftpack/src/dfftpack/dcosqf.f:21:72: DO 101 K=2,NS2 2 scipy/fftpack/src/dfftpack/dcosqf.f:23:12: XH(K) = X(K)+X(KC) 1 Warning: Array reference at (1) out of bounds (2 > 1) in loop beginning at (2) scipy/fftpack/src/dfftpack/dcosqf.f:23:19: scipy/fftpack/src/dfftpack/dcosqf.f:21:72: DO 101 K=2,NS2 2 scipy/fftpack/src/dfftpack/dcosqf.f:23:19: XH(K) = X(K)+X(KC) 1 Warning: Array reference at (1) out of bounds (2 > 1) in loop beginning at (2) scipy/fftpack/src/dfftpack/dcosqf.f:24:20: scipy/fftpack/src/dfftpack/dcosqf.f:21:72: DO 101 K=2,NS2 2 scipy/fftpack/src/dfftpack/dcosqf.f:24:20: XH(KC) = X(K)-X(KC) 1 Warning: Array reference at (1) out of bounds (2 > 1) in loop beginning at (2) scipy/fftpack/src/dfftpack/dcosqf.f:30:11: scipy/fftpack/src/dfftpack/dcosqf.f:28:72: DO 102 K=2,NS2 2 scipy/fftpack/src/dfftpack/dcosqf.f:30:11: X(K) = W(K-1)*XH(KC)+W(KC-1)*XH(K) 1 Warning: Array reference at (1) out of bounds (2 > 1) in loop beginning at (2) scipy/fftpack/src/dfftpack/dcosqf.f:30:41: scipy/fftpack/src/dfftpack/dcosqf.f:28:72: DO 102 K=2,NS2 2 scipy/fftpack/src/dfftpack/dcosqf.f:30:41: X(K) = W(K-1)*XH(KC)+W(KC-1)*XH(K) 1 Warning: Array reference at (1) out of bounds (2 > 1) in loop beginning at (2) scipy/fftpack/src/dfftpack/dcosqf.f:31:27: scipy/fftpack/src/dfftpack/dcosqf.f:28:72: DO 102 K=2,NS2 2 scipy/fftpack/src/dfftpack/dcosqf.f:31:27: X(KC) = W(K-1)*XH(K)-W(KC-1)*XH(KC) 1 Warning: Array reference at (1) out of bounds (2 > 1) in loop beginning at (2) scipy/fftpack/src/dfftpack/dcosqf.f:36:18: DO 103 I=3,N,2 2 XIM1 = X(I-1)-X(I) 1 Warning: Array reference at (1) out of bounds (2 > 1) in loop beginning at (2) scipy/fftpack/src/dfftpack/dcosqf.f:36:25: DO 103 I=3,N,2 2 XIM1 = X(I-1)-X(I) 1 Warning: Array reference at (1) out of bounds (3 > 1) in loop beginning at (2) scipy/fftpack/src/dfftpack/dcosqf.f:37:11: scipy/fftpack/src/dfftpack/dcosqf.f:35:72: DO 103 I=3,N,2 2 scipy/fftpack/src/dfftpack/dcosqf.f:37:11: X(I) = X(I-1)+X(I) 1 Warning: Array reference at (1) out of bounds (3 > 1) in loop beginning at (2) scipy/fftpack/src/dfftpack/dcosqf.f:37:18: scipy/fftpack/src/dfftpack/dcosqf.f:35:72: DO 103 I=3,N,2 2 scipy/fftpack/src/dfftpack/dcosqf.f:37:18: X(I) = X(I-1)+X(I) 1 Warning: Array reference at (1) out of bounds (2 > 1) in loop beginning at (2) scipy/fftpack/src/dfftpack/dcosqf.f:37:25: scipy/fftpack/src/dfftpack/dcosqf.f:35:72: DO 103 I=3,N,2 2 scipy/fftpack/src/dfftpack/dcosqf.f:37:25: X(I) = X(I-1)+X(I) 1 Warning: Array reference at (1) out of bounds (3 > 1) in loop beginning at (2) scipy/fftpack/src/dfftpack/dcosqf.f:38:11: scipy/fftpack/src/dfftpack/dcosqf.f:35:72: DO 103 I=3,N,2 2 scipy/fftpack/src/dfftpack/dcosqf.f:38:11: X(I-1) = XIM1 1 Warning: Array reference at (1) out of bounds (2 > 1) in loop beginning at (2) gfortran:f77: scipy/fftpack/src/dfftpack/dsinqi.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/fftpack/src/dfftpack/dcosti.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran scipy/fftpack/src/dfftpack/dcosti.f:14:15: scipy/fftpack/src/dfftpack/dcosti.f:11:72: DO 101 K=2,NS2 2 scipy/fftpack/src/dfftpack/dcosti.f:14:15: WSAVE(K) = 2.0D0*SIN(FK*DT) 1 Warning: Array reference at (1) out of bounds (2 > 1) in loop beginning at (2) gfortran:f77: scipy/fftpack/src/dfftpack/dcosqb.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran scipy/fftpack/src/dfftpack/dcosqb.f:24:18: DO 101 I=3,N,2 2 XIM1 = X(I-1)+X(I) 1 Warning: Array reference at (1) out of bounds (2 > 1) in loop beginning at (2) scipy/fftpack/src/dfftpack/dcosqb.f:24:25: DO 101 I=3,N,2 2 XIM1 = X(I-1)+X(I) 1 Warning: Array reference at (1) out of bounds (3 > 1) in loop beginning at (2) scipy/fftpack/src/dfftpack/dcosqb.f:25:11: scipy/fftpack/src/dfftpack/dcosqb.f:23:72: DO 101 I=3,N,2 2 scipy/fftpack/src/dfftpack/dcosqb.f:25:11: X(I) = X(I)-X(I-1) 1 Warning: Array reference at (1) out of bounds (3 > 1) in loop beginning at (2) scipy/fftpack/src/dfftpack/dcosqb.f:25:18: scipy/fftpack/src/dfftpack/dcosqb.f:23:72: DO 101 I=3,N,2 2 scipy/fftpack/src/dfftpack/dcosqb.f:25:18: X(I) = X(I)-X(I-1) 1 Warning: Array reference at (1) out of bounds (3 > 1) in loop beginning at (2) scipy/fftpack/src/dfftpack/dcosqb.f:25:23: scipy/fftpack/src/dfftpack/dcosqb.f:23:72: DO 101 I=3,N,2 2 scipy/fftpack/src/dfftpack/dcosqb.f:25:23: X(I) = X(I)-X(I-1) 1 Warning: Array reference at (1) out of bounds (2 > 1) in loop beginning at (2) scipy/fftpack/src/dfftpack/dcosqb.f:26:11: scipy/fftpack/src/dfftpack/dcosqb.f:23:72: DO 101 I=3,N,2 2 scipy/fftpack/src/dfftpack/dcosqb.f:26:11: X(I-1) = XIM1 1 Warning: Array reference at (1) out of bounds (2 > 1) in loop beginning at (2) scipy/fftpack/src/dfftpack/dcosqb.f:34:12: scipy/fftpack/src/dfftpack/dcosqb.f:32:72: DO 102 K=2,NS2 2 scipy/fftpack/src/dfftpack/dcosqb.f:34:12: XH(K) = W(K-1)*X(KC)+W(KC-1)*X(K) 1 Warning: Array reference at (1) out of bounds (2 > 1) in loop beginning at (2) scipy/fftpack/src/dfftpack/dcosqb.f:34:40: scipy/fftpack/src/dfftpack/dcosqb.f:32:72: DO 102 K=2,NS2 2 scipy/fftpack/src/dfftpack/dcosqb.f:34:40: XH(K) = W(K-1)*X(KC)+W(KC-1)*X(K) 1 Warning: Array reference at (1) out of bounds (2 > 1) in loop beginning at (2) scipy/fftpack/src/dfftpack/dcosqb.f:35:27: scipy/fftpack/src/dfftpack/dcosqb.f:32:72: DO 102 K=2,NS2 2 scipy/fftpack/src/dfftpack/dcosqb.f:35:27: XH(KC) = W(K-1)*X(K)-W(KC-1)*X(KC) 1 Warning: Array reference at (1) out of bounds (2 > 1) in loop beginning at (2) scipy/fftpack/src/dfftpack/dcosqb.f:40:11: scipy/fftpack/src/dfftpack/dcosqb.f:38:72: DO 103 K=2,NS2 2 scipy/fftpack/src/dfftpack/dcosqb.f:40:11: X(K) = XH(K)+XH(KC) 1 Warning: Array reference at (1) out of bounds (2 > 1) in loop beginning at (2) scipy/fftpack/src/dfftpack/dcosqb.f:40:19: scipy/fftpack/src/dfftpack/dcosqb.f:38:72: DO 103 K=2,NS2 2 scipy/fftpack/src/dfftpack/dcosqb.f:40:19: X(K) = XH(K)+XH(KC) 1 Warning: Array reference at (1) out of bounds (2 > 1) in loop beginning at (2) scipy/fftpack/src/dfftpack/dcosqb.f:41:20: scipy/fftpack/src/dfftpack/dcosqb.f:38:72: DO 103 K=2,NS2 2 scipy/fftpack/src/dfftpack/dcosqb.f:41:20: X(KC) = XH(K)-XH(KC) 1 Warning: Array reference at (1) out of bounds (2 > 1) in loop beginning at (2) gfortran:f77: scipy/fftpack/src/dfftpack/dfftf1.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran scipy/fftpack/src/dfftpack/dfftf1.f:320:43: scipy/fftpack/src/dfftpack/dfftf1.f:318:72: DO 103 I=3,IDO,2 2 scipy/fftpack/src/dfftpack/dfftf1.f:320:43: CR2 = WA1(I-2)*CC(I-1,K,2)+WA1(I-1)*CC(I,K,2) 1 Warning: Array reference at (1) out of bounds (2 > 1) in loop beginning at (2) scipy/fftpack/src/dfftpack/dfftf1.f:321:41: scipy/fftpack/src/dfftpack/dfftf1.f:318:72: DO 103 I=3,IDO,2 2 scipy/fftpack/src/dfftpack/dfftf1.f:321:41: CI2 = WA1(I-2)*CC(I,K,2)-WA1(I-1)*CC(I-1,K,2) 1 Warning: Array reference at (1) out of bounds (2 > 1) in loop beginning at (2) scipy/fftpack/src/dfftpack/dfftf1.f:322:43: scipy/fftpack/src/dfftpack/dfftf1.f:318:72: DO 103 I=3,IDO,2 2 scipy/fftpack/src/dfftpack/dfftf1.f:322:43: CR3 = WA2(I-2)*CC(I-1,K,3)+WA2(I-1)*CC(I,K,3) 1 Warning: Array reference at (1) out of bounds (2 > 1) in loop beginning at (2) scipy/fftpack/src/dfftpack/dfftf1.f:323:41: scipy/fftpack/src/dfftpack/dfftf1.f:318:72: DO 103 I=3,IDO,2 2 scipy/fftpack/src/dfftpack/dfftf1.f:323:41: CI3 = WA2(I-2)*CC(I,K,3)-WA2(I-1)*CC(I-1,K,3) 1 Warning: Array reference at (1) out of bounds (2 > 1) in loop beginning at (2) scipy/fftpack/src/dfftpack/dfftf1.f:324:43: scipy/fftpack/src/dfftpack/dfftf1.f:318:72: DO 103 I=3,IDO,2 2 scipy/fftpack/src/dfftpack/dfftf1.f:324:43: CR4 = WA3(I-2)*CC(I-1,K,4)+WA3(I-1)*CC(I,K,4) 1 Warning: Array reference at (1) out of bounds (2 > 1) in loop beginning at (2) scipy/fftpack/src/dfftpack/dfftf1.f:325:41: scipy/fftpack/src/dfftpack/dfftf1.f:318:72: DO 103 I=3,IDO,2 2 scipy/fftpack/src/dfftpack/dfftf1.f:325:41: CI4 = WA3(I-2)*CC(I,K,4)-WA3(I-1)*CC(I-1,K,4) 1 Warning: Array reference at (1) out of bounds (2 > 1) in loop beginning at (2) scipy/fftpack/src/dfftpack/dfftf1.f:246:43: scipy/fftpack/src/dfftpack/dfftf1.f:244:72: DO 103 I=3,IDO,2 2 scipy/fftpack/src/dfftpack/dfftf1.f:246:43: TR2 = WA1(I-2)*CC(I-1,K,2)+WA1(I-1)*CC(I,K,2) 1 Warning: Array reference at (1) out of bounds (2 > 1) in loop beginning at (2) scipy/fftpack/src/dfftpack/dfftf1.f:247:41: scipy/fftpack/src/dfftpack/dfftf1.f:244:72: DO 103 I=3,IDO,2 2 scipy/fftpack/src/dfftpack/dfftf1.f:247:41: TI2 = WA1(I-2)*CC(I,K,2)-WA1(I-1)*CC(I-1,K,2) 1 Warning: Array reference at (1) out of bounds (2 > 1) in loop beginning at (2) scipy/fftpack/src/dfftpack/dfftf1.f:279:43: scipy/fftpack/src/dfftpack/dfftf1.f:277:72: DO 102 I=3,IDO,2 2 scipy/fftpack/src/dfftpack/dfftf1.f:279:43: DR2 = WA1(I-2)*CC(I-1,K,2)+WA1(I-1)*CC(I,K,2) 1 Warning: Array reference at (1) out of bounds (2 > 1) in loop beginning at (2) scipy/fftpack/src/dfftpack/dfftf1.f:280:41: scipy/fftpack/src/dfftpack/dfftf1.f:277:72: DO 102 I=3,IDO,2 2 scipy/fftpack/src/dfftpack/dfftf1.f:280:41: DI2 = WA1(I-2)*CC(I,K,2)-WA1(I-1)*CC(I-1,K,2) 1 Warning: Array reference at (1) out of bounds (2 > 1) in loop beginning at (2) scipy/fftpack/src/dfftpack/dfftf1.f:281:43: scipy/fftpack/src/dfftpack/dfftf1.f:277:72: DO 102 I=3,IDO,2 2 scipy/fftpack/src/dfftpack/dfftf1.f:281:43: DR3 = WA2(I-2)*CC(I-1,K,3)+WA2(I-1)*CC(I,K,3) 1 Warning: Array reference at (1) out of bounds (2 > 1) in loop beginning at (2) scipy/fftpack/src/dfftpack/dfftf1.f:282:41: scipy/fftpack/src/dfftpack/dfftf1.f:277:72: DO 102 I=3,IDO,2 2 scipy/fftpack/src/dfftpack/dfftf1.f:282:41: DI3 = WA2(I-2)*CC(I,K,3)-WA2(I-1)*CC(I-1,K,3) 1 Warning: Array reference at (1) out of bounds (2 > 1) in loop beginning at (2) scipy/fftpack/src/dfftpack/dfftf1.f:381:43: scipy/fftpack/src/dfftpack/dfftf1.f:379:72: DO 102 I=3,IDO,2 2 scipy/fftpack/src/dfftpack/dfftf1.f:381:43: DR2 = WA1(I-2)*CC(I-1,K,2)+WA1(I-1)*CC(I,K,2) 1 Warning: Array reference at (1) out of bounds (2 > 1) in loop beginning at (2) scipy/fftpack/src/dfftpack/dfftf1.f:382:41: scipy/fftpack/src/dfftpack/dfftf1.f:379:72: DO 102 I=3,IDO,2 2 scipy/fftpack/src/dfftpack/dfftf1.f:382:41: DI2 = WA1(I-2)*CC(I,K,2)-WA1(I-1)*CC(I-1,K,2) 1 Warning: Array reference at (1) out of bounds (2 > 1) in loop beginning at (2) scipy/fftpack/src/dfftpack/dfftf1.f:383:43: scipy/fftpack/src/dfftpack/dfftf1.f:379:72: DO 102 I=3,IDO,2 2 scipy/fftpack/src/dfftpack/dfftf1.f:383:43: DR3 = WA2(I-2)*CC(I-1,K,3)+WA2(I-1)*CC(I,K,3) 1 Warning: Array reference at (1) out of bounds (2 > 1) in loop beginning at (2) scipy/fftpack/src/dfftpack/dfftf1.f:384:41: scipy/fftpack/src/dfftpack/dfftf1.f:379:72: DO 102 I=3,IDO,2 2 scipy/fftpack/src/dfftpack/dfftf1.f:384:41: DI3 = WA2(I-2)*CC(I,K,3)-WA2(I-1)*CC(I-1,K,3) 1 Warning: Array reference at (1) out of bounds (2 > 1) in loop beginning at (2) scipy/fftpack/src/dfftpack/dfftf1.f:385:43: scipy/fftpack/src/dfftpack/dfftf1.f:379:72: DO 102 I=3,IDO,2 2 scipy/fftpack/src/dfftpack/dfftf1.f:385:43: DR4 = WA3(I-2)*CC(I-1,K,4)+WA3(I-1)*CC(I,K,4) 1 Warning: Array reference at (1) out of bounds (2 > 1) in loop beginning at (2) scipy/fftpack/src/dfftpack/dfftf1.f:386:41: scipy/fftpack/src/dfftpack/dfftf1.f:379:72: DO 102 I=3,IDO,2 2 scipy/fftpack/src/dfftpack/dfftf1.f:386:41: DI4 = WA3(I-2)*CC(I,K,4)-WA3(I-1)*CC(I-1,K,4) 1 Warning: Array reference at (1) out of bounds (2 > 1) in loop beginning at (2) scipy/fftpack/src/dfftpack/dfftf1.f:387:43: scipy/fftpack/src/dfftpack/dfftf1.f:379:72: DO 102 I=3,IDO,2 2 scipy/fftpack/src/dfftpack/dfftf1.f:387:43: DR5 = WA4(I-2)*CC(I-1,K,5)+WA4(I-1)*CC(I,K,5) 1 Warning: Array reference at (1) out of bounds (2 > 1) in loop beginning at (2) scipy/fftpack/src/dfftpack/dfftf1.f:388:41: scipy/fftpack/src/dfftpack/dfftf1.f:379:72: DO 102 I=3,IDO,2 2 scipy/fftpack/src/dfftpack/dfftf1.f:388:41: DI5 = WA4(I-2)*CC(I,K,5)-WA4(I-1)*CC(I-1,K,5) 1 Warning: Array reference at (1) out of bounds (2 > 1) in loop beginning at (2) gfortran:f77: scipy/fftpack/src/dfftpack/dffti1.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/fftpack/src/dfftpack/dsint.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/fftpack/src/dfftpack/dcost.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/fftpack/src/dfftpack/zfftf.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/fftpack/src/dfftpack/dfftf.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/fftpack/src/dfftpack/dsinqb.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran scipy/fftpack/src/dfftpack/dsinqb.f:9:11: DO 102 K=2,N,2 2 X(K) = -X(K) 1 Warning: Array reference at (1) out of bounds (2 > 1) in loop beginning at (2) scipy/fftpack/src/dfftpack/dsinqb.f:9:19: DO 102 K=2,N,2 2 X(K) = -X(K) 1 Warning: Array reference at (1) out of bounds (2 > 1) in loop beginning at (2) gfortran:f77: scipy/fftpack/src/dfftpack/zfftb.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/fftpack/src/dfftpack/zfftb1.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran scipy/fftpack/src/dfftpack/zfftb1.f:295:43: scipy/fftpack/src/dfftpack/zfftb1.f:278:72: DO 103 I=2,IDO,2 2 scipy/fftpack/src/dfftpack/zfftb1.f:295:43: CH(I-1,K,2) = WA1(I-1)*CR2-WA1(I)*CI2 1 Warning: Array reference at (1) out of bounds (2 > 1) in loop beginning at (2) scipy/fftpack/src/dfftpack/zfftb1.f:296:41: scipy/fftpack/src/dfftpack/zfftb1.f:278:72: DO 103 I=2,IDO,2 2 scipy/fftpack/src/dfftpack/zfftb1.f:296:41: CH(I,K,2) = WA1(I-1)*CI2+WA1(I)*CR2 1 Warning: Array reference at (1) out of bounds (2 > 1) in loop beginning at (2) scipy/fftpack/src/dfftpack/zfftb1.f:297:43: scipy/fftpack/src/dfftpack/zfftb1.f:278:72: DO 103 I=2,IDO,2 2 scipy/fftpack/src/dfftpack/zfftb1.f:297:43: CH(I-1,K,3) = WA2(I-1)*CR3-WA2(I)*CI3 1 Warning: Array reference at (1) out of bounds (2 > 1) in loop beginning at (2) scipy/fftpack/src/dfftpack/zfftb1.f:298:41: scipy/fftpack/src/dfftpack/zfftb1.f:278:72: DO 103 I=2,IDO,2 2 scipy/fftpack/src/dfftpack/zfftb1.f:298:41: CH(I,K,3) = WA2(I-1)*CI3+WA2(I)*CR3 1 Warning: Array reference at (1) out of bounds (2 > 1) in loop beginning at (2) scipy/fftpack/src/dfftpack/zfftb1.f:299:43: scipy/fftpack/src/dfftpack/zfftb1.f:278:72: DO 103 I=2,IDO,2 2 scipy/fftpack/src/dfftpack/zfftb1.f:299:43: CH(I-1,K,4) = WA3(I-1)*CR4-WA3(I)*CI4 1 Warning: Array reference at (1) out of bounds (2 > 1) in loop beginning at (2) scipy/fftpack/src/dfftpack/zfftb1.f:300:41: scipy/fftpack/src/dfftpack/zfftb1.f:278:72: DO 103 I=2,IDO,2 2 scipy/fftpack/src/dfftpack/zfftb1.f:300:41: CH(I,K,4) = WA3(I-1)*CI4+WA3(I)*CR4 1 Warning: Array reference at (1) out of bounds (2 > 1) in loop beginning at (2) scipy/fftpack/src/dfftpack/zfftb1.f:200:41: scipy/fftpack/src/dfftpack/zfftb1.f:195:72: DO 103 I=2,IDO,2 2 scipy/fftpack/src/dfftpack/zfftb1.f:200:41: CH(I,K,2) = WA1(I-1)*TI2+WA1(I)*TR2 1 Warning: Array reference at (1) out of bounds (2 > 1) in loop beginning at (2) scipy/fftpack/src/dfftpack/zfftb1.f:201:43: scipy/fftpack/src/dfftpack/zfftb1.f:195:72: DO 103 I=2,IDO,2 2 scipy/fftpack/src/dfftpack/zfftb1.f:201:43: CH(I-1,K,2) = WA1(I-1)*TR2-WA1(I)*TI2 1 Warning: Array reference at (1) out of bounds (2 > 1) in loop beginning at (2) scipy/fftpack/src/dfftpack/zfftb1.f:243:41: scipy/fftpack/src/dfftpack/zfftb1.f:230:72: DO 103 I=2,IDO,2 2 scipy/fftpack/src/dfftpack/zfftb1.f:243:41: CH(I,K,2) = WA1(I-1)*DI2+WA1(I)*DR2 1 Warning: Array reference at (1) out of bounds (2 > 1) in loop beginning at (2) scipy/fftpack/src/dfftpack/zfftb1.f:244:43: scipy/fftpack/src/dfftpack/zfftb1.f:230:72: DO 103 I=2,IDO,2 2 scipy/fftpack/src/dfftpack/zfftb1.f:244:43: CH(I-1,K,2) = WA1(I-1)*DR2-WA1(I)*DI2 1 Warning: Array reference at (1) out of bounds (2 > 1) in loop beginning at (2) scipy/fftpack/src/dfftpack/zfftb1.f:245:41: scipy/fftpack/src/dfftpack/zfftb1.f:230:72: DO 103 I=2,IDO,2 2 scipy/fftpack/src/dfftpack/zfftb1.f:245:41: CH(I,K,3) = WA2(I-1)*DI3+WA2(I)*DR3 1 Warning: Array reference at (1) out of bounds (2 > 1) in loop beginning at (2) scipy/fftpack/src/dfftpack/zfftb1.f:246:43: scipy/fftpack/src/dfftpack/zfftb1.f:230:72: DO 103 I=2,IDO,2 2 scipy/fftpack/src/dfftpack/zfftb1.f:246:43: CH(I-1,K,3) = WA2(I-1)*DR3-WA2(I)*DI3 1 Warning: Array reference at (1) out of bounds (2 > 1) in loop beginning at (2) scipy/fftpack/src/dfftpack/zfftb1.f:373:43: scipy/fftpack/src/dfftpack/zfftb1.f:346:72: DO 103 I=2,IDO,2 2 scipy/fftpack/src/dfftpack/zfftb1.f:373:43: CH(I-1,K,2) = WA1(I-1)*DR2-WA1(I)*DI2 1 Warning: Array reference at (1) out of bounds (2 > 1) in loop beginning at (2) scipy/fftpack/src/dfftpack/zfftb1.f:374:41: scipy/fftpack/src/dfftpack/zfftb1.f:346:72: DO 103 I=2,IDO,2 2 scipy/fftpack/src/dfftpack/zfftb1.f:374:41: CH(I,K,2) = WA1(I-1)*DI2+WA1(I)*DR2 1 Warning: Array reference at (1) out of bounds (2 > 1) in loop beginning at (2) scipy/fftpack/src/dfftpack/zfftb1.f:375:43: scipy/fftpack/src/dfftpack/zfftb1.f:346:72: DO 103 I=2,IDO,2 2 scipy/fftpack/src/dfftpack/zfftb1.f:375:43: CH(I-1,K,3) = WA2(I-1)*DR3-WA2(I)*DI3 1 Warning: Array reference at (1) out of bounds (2 > 1) in loop beginning at (2) scipy/fftpack/src/dfftpack/zfftb1.f:376:41: scipy/fftpack/src/dfftpack/zfftb1.f:346:72: DO 103 I=2,IDO,2 2 scipy/fftpack/src/dfftpack/zfftb1.f:376:41: CH(I,K,3) = WA2(I-1)*DI3+WA2(I)*DR3 1 Warning: Array reference at (1) out of bounds (2 > 1) in loop beginning at (2) scipy/fftpack/src/dfftpack/zfftb1.f:377:43: scipy/fftpack/src/dfftpack/zfftb1.f:346:72: DO 103 I=2,IDO,2 2 scipy/fftpack/src/dfftpack/zfftb1.f:377:43: CH(I-1,K,4) = WA3(I-1)*DR4-WA3(I)*DI4 1 Warning: Array reference at (1) out of bounds (2 > 1) in loop beginning at (2) scipy/fftpack/src/dfftpack/zfftb1.f:378:41: scipy/fftpack/src/dfftpack/zfftb1.f:346:72: DO 103 I=2,IDO,2 2 scipy/fftpack/src/dfftpack/zfftb1.f:378:41: CH(I,K,4) = WA3(I-1)*DI4+WA3(I)*DR4 1 Warning: Array reference at (1) out of bounds (2 > 1) in loop beginning at (2) scipy/fftpack/src/dfftpack/zfftb1.f:379:43: scipy/fftpack/src/dfftpack/zfftb1.f:346:72: DO 103 I=2,IDO,2 2 scipy/fftpack/src/dfftpack/zfftb1.f:379:43: CH(I-1,K,5) = WA4(I-1)*DR5-WA4(I)*DI5 1 Warning: Array reference at (1) out of bounds (2 > 1) in loop beginning at (2) scipy/fftpack/src/dfftpack/zfftb1.f:380:41: scipy/fftpack/src/dfftpack/zfftb1.f:346:72: DO 103 I=2,IDO,2 2 scipy/fftpack/src/dfftpack/zfftb1.f:380:41: CH(I,K,5) = WA4(I-1)*DI5+WA4(I)*DR5 1 Warning: Array reference at (1) out of bounds (2 > 1) in loop beginning at (2) gfortran:f77: scipy/fftpack/src/dfftpack/zffti.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/fftpack/src/dfftpack/dfftb1.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran scipy/fftpack/src/dfftpack/dfftb1.f:333:43: scipy/fftpack/src/dfftpack/dfftb1.f:315:72: DO 103 I=3,IDO,2 2 scipy/fftpack/src/dfftpack/dfftb1.f:333:43: CH(I-1,K,2) = WA1(I-2)*CR2-WA1(I-1)*CI2 1 Warning: Array reference at (1) out of bounds (2 > 1) in loop beginning at (2) scipy/fftpack/src/dfftpack/dfftb1.f:334:41: scipy/fftpack/src/dfftpack/dfftb1.f:315:72: DO 103 I=3,IDO,2 2 scipy/fftpack/src/dfftpack/dfftb1.f:334:41: CH(I,K,2) = WA1(I-2)*CI2+WA1(I-1)*CR2 1 Warning: Array reference at (1) out of bounds (2 > 1) in loop beginning at (2) scipy/fftpack/src/dfftpack/dfftb1.f:335:43: scipy/fftpack/src/dfftpack/dfftb1.f:315:72: DO 103 I=3,IDO,2 2 scipy/fftpack/src/dfftpack/dfftb1.f:335:43: CH(I-1,K,3) = WA2(I-2)*CR3-WA2(I-1)*CI3 1 Warning: Array reference at (1) out of bounds (2 > 1) in loop beginning at (2) scipy/fftpack/src/dfftpack/dfftb1.f:336:41: scipy/fftpack/src/dfftpack/dfftb1.f:315:72: DO 103 I=3,IDO,2 2 scipy/fftpack/src/dfftpack/dfftb1.f:336:41: CH(I,K,3) = WA2(I-2)*CI3+WA2(I-1)*CR3 1 Warning: Array reference at (1) out of bounds (2 > 1) in loop beginning at (2) scipy/fftpack/src/dfftpack/dfftb1.f:337:43: scipy/fftpack/src/dfftpack/dfftb1.f:315:72: DO 103 I=3,IDO,2 2 scipy/fftpack/src/dfftpack/dfftb1.f:337:43: CH(I-1,K,4) = WA3(I-2)*CR4-WA3(I-1)*CI4 1 Warning: Array reference at (1) out of bounds (2 > 1) in loop beginning at (2) scipy/fftpack/src/dfftpack/dfftb1.f:338:41: scipy/fftpack/src/dfftpack/dfftb1.f:315:72: DO 103 I=3,IDO,2 2 scipy/fftpack/src/dfftpack/dfftb1.f:338:41: CH(I,K,4) = WA3(I-2)*CI4+WA3(I-1)*CR4 1 Warning: Array reference at (1) out of bounds (2 > 1) in loop beginning at (2) scipy/fftpack/src/dfftpack/dfftb1.f:243:43: scipy/fftpack/src/dfftpack/dfftb1.f:237:72: DO 103 I=3,IDO,2 2 scipy/fftpack/src/dfftpack/dfftb1.f:243:43: CH(I-1,K,2) = WA1(I-2)*TR2-WA1(I-1)*TI2 1 Warning: Array reference at (1) out of bounds (2 > 1) in loop beginning at (2) scipy/fftpack/src/dfftpack/dfftb1.f:244:41: scipy/fftpack/src/dfftpack/dfftb1.f:237:72: DO 103 I=3,IDO,2 2 scipy/fftpack/src/dfftpack/dfftb1.f:244:41: CH(I,K,2) = WA1(I-2)*TI2+WA1(I-1)*TR2 1 Warning: Array reference at (1) out of bounds (2 > 1) in loop beginning at (2) scipy/fftpack/src/dfftpack/dfftb1.f:286:43: scipy/fftpack/src/dfftpack/dfftb1.f:272:72: DO 102 I=3,IDO,2 2 scipy/fftpack/src/dfftpack/dfftb1.f:286:43: CH(I-1,K,2) = WA1(I-2)*DR2-WA1(I-1)*DI2 1 Warning: Array reference at (1) out of bounds (2 > 1) in loop beginning at (2) scipy/fftpack/src/dfftpack/dfftb1.f:287:41: scipy/fftpack/src/dfftpack/dfftb1.f:272:72: DO 102 I=3,IDO,2 2 scipy/fftpack/src/dfftpack/dfftb1.f:287:41: CH(I,K,2) = WA1(I-2)*DI2+WA1(I-1)*DR2 1 Warning: Array reference at (1) out of bounds (2 > 1) in loop beginning at (2) scipy/fftpack/src/dfftpack/dfftb1.f:288:43: scipy/fftpack/src/dfftpack/dfftb1.f:272:72: DO 102 I=3,IDO,2 2 scipy/fftpack/src/dfftpack/dfftb1.f:288:43: CH(I-1,K,3) = WA2(I-2)*DR3-WA2(I-1)*DI3 1 Warning: Array reference at (1) out of bounds (2 > 1) in loop beginning at (2) scipy/fftpack/src/dfftpack/dfftb1.f:289:41: scipy/fftpack/src/dfftpack/dfftb1.f:272:72: DO 102 I=3,IDO,2 2 scipy/fftpack/src/dfftpack/dfftb1.f:289:41: CH(I,K,3) = WA2(I-2)*DI3+WA2(I-1)*DR3 1 Warning: Array reference at (1) out of bounds (2 > 1) in loop beginning at (2) scipy/fftpack/src/dfftpack/dfftb1.f:412:43: scipy/fftpack/src/dfftpack/dfftb1.f:384:72: DO 102 I=3,IDO,2 2 scipy/fftpack/src/dfftpack/dfftb1.f:412:43: CH(I-1,K,2) = WA1(I-2)*DR2-WA1(I-1)*DI2 1 Warning: Array reference at (1) out of bounds (2 > 1) in loop beginning at (2) scipy/fftpack/src/dfftpack/dfftb1.f:413:41: scipy/fftpack/src/dfftpack/dfftb1.f:384:72: DO 102 I=3,IDO,2 2 scipy/fftpack/src/dfftpack/dfftb1.f:413:41: CH(I,K,2) = WA1(I-2)*DI2+WA1(I-1)*DR2 1 Warning: Array reference at (1) out of bounds (2 > 1) in loop beginning at (2) scipy/fftpack/src/dfftpack/dfftb1.f:414:43: scipy/fftpack/src/dfftpack/dfftb1.f:384:72: DO 102 I=3,IDO,2 2 scipy/fftpack/src/dfftpack/dfftb1.f:414:43: CH(I-1,K,3) = WA2(I-2)*DR3-WA2(I-1)*DI3 1 Warning: Array reference at (1) out of bounds (2 > 1) in loop beginning at (2) scipy/fftpack/src/dfftpack/dfftb1.f:415:41: scipy/fftpack/src/dfftpack/dfftb1.f:384:72: DO 102 I=3,IDO,2 2 scipy/fftpack/src/dfftpack/dfftb1.f:415:41: CH(I,K,3) = WA2(I-2)*DI3+WA2(I-1)*DR3 1 Warning: Array reference at (1) out of bounds (2 > 1) in loop beginning at (2) scipy/fftpack/src/dfftpack/dfftb1.f:416:43: scipy/fftpack/src/dfftpack/dfftb1.f:384:72: DO 102 I=3,IDO,2 2 scipy/fftpack/src/dfftpack/dfftb1.f:416:43: CH(I-1,K,4) = WA3(I-2)*DR4-WA3(I-1)*DI4 1 Warning: Array reference at (1) out of bounds (2 > 1) in loop beginning at (2) scipy/fftpack/src/dfftpack/dfftb1.f:417:41: scipy/fftpack/src/dfftpack/dfftb1.f:384:72: DO 102 I=3,IDO,2 2 scipy/fftpack/src/dfftpack/dfftb1.f:417:41: CH(I,K,4) = WA3(I-2)*DI4+WA3(I-1)*DR4 1 Warning: Array reference at (1) out of bounds (2 > 1) in loop beginning at (2) scipy/fftpack/src/dfftpack/dfftb1.f:418:43: scipy/fftpack/src/dfftpack/dfftb1.f:384:72: DO 102 I=3,IDO,2 2 scipy/fftpack/src/dfftpack/dfftb1.f:418:43: CH(I-1,K,5) = WA4(I-2)*DR5-WA4(I-1)*DI5 1 Warning: Array reference at (1) out of bounds (2 > 1) in loop beginning at (2) scipy/fftpack/src/dfftpack/dfftb1.f:419:41: scipy/fftpack/src/dfftpack/dfftb1.f:384:72: DO 102 I=3,IDO,2 2 scipy/fftpack/src/dfftpack/dfftb1.f:419:41: CH(I,K,5) = WA4(I-2)*DI5+WA4(I-1)*DR5 1 Warning: Array reference at (1) out of bounds (2 > 1) in loop beginning at (2) gfortran:f77: scipy/fftpack/src/dfftpack/dsint1.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran ar: adding 23 object files to build/temp.linux-ppc64le-2.7/libdfftpack.a building 'fftpack' library compiling Fortran sources Fortran f77 compiler: /usr/bin/gfortran -Wall -g -ffixed-form -fno-second-underscore -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -fPIC -cpp -O3 -funroll-loops Fortran f90 compiler: /usr/bin/gfortran -Wall -g -fno-second-underscore -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -fPIC -cpp -O3 -funroll-loops Fortran fix compiler: /usr/bin/gfortran -Wall -g -ffixed-form -fno-second-underscore -Wall -g -fno-second-underscore -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -fPIC -cpp -O3 -funroll-loops creating build/temp.linux-ppc64le-2.7/scipy/fftpack/src/fftpack compile options: '-I/usr/lib64/python2.7/site-packages/numpy/core/include -c' gfortran:f77: scipy/fftpack/src/fftpack/rfftf.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/fftpack/src/fftpack/costi.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/fftpack/src/fftpack/cosqf.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran scipy/fftpack/src/fftpack/cosqf.f:20:12: scipy/fftpack/src/fftpack/cosqf.f:18:72: DO 101 K=2,NS2 2 scipy/fftpack/src/fftpack/cosqf.f:20:12: XH(K) = X(K)+X(KC) 1 Warning: Array reference at (1) out of bounds (2 > 1) in loop beginning at (2) scipy/fftpack/src/fftpack/cosqf.f:20:19: scipy/fftpack/src/fftpack/cosqf.f:18:72: DO 101 K=2,NS2 2 scipy/fftpack/src/fftpack/cosqf.f:20:19: XH(K) = X(K)+X(KC) 1 Warning: Array reference at (1) out of bounds (2 > 1) in loop beginning at (2) scipy/fftpack/src/fftpack/cosqf.f:21:20: scipy/fftpack/src/fftpack/cosqf.f:18:72: DO 101 K=2,NS2 2 scipy/fftpack/src/fftpack/cosqf.f:21:20: XH(KC) = X(K)-X(KC) 1 Warning: Array reference at (1) out of bounds (2 > 1) in loop beginning at (2) scipy/fftpack/src/fftpack/cosqf.f:27:11: scipy/fftpack/src/fftpack/cosqf.f:25:72: DO 102 K=2,NS2 2 scipy/fftpack/src/fftpack/cosqf.f:27:11: X(K) = W(K-1)*XH(KC)+W(KC-1)*XH(K) 1 Warning: Array reference at (1) out of bounds (2 > 1) in loop beginning at (2) scipy/fftpack/src/fftpack/cosqf.f:27:41: scipy/fftpack/src/fftpack/cosqf.f:25:72: DO 102 K=2,NS2 2 scipy/fftpack/src/fftpack/cosqf.f:27:41: X(K) = W(K-1)*XH(KC)+W(KC-1)*XH(K) 1 Warning: Array reference at (1) out of bounds (2 > 1) in loop beginning at (2) scipy/fftpack/src/fftpack/cosqf.f:28:27: scipy/fftpack/src/fftpack/cosqf.f:25:72: DO 102 K=2,NS2 2 scipy/fftpack/src/fftpack/cosqf.f:28:27: X(KC) = W(K-1)*XH(K)-W(KC-1)*XH(KC) 1 Warning: Array reference at (1) out of bounds (2 > 1) in loop beginning at (2) scipy/fftpack/src/fftpack/cosqf.f:33:18: DO 103 I=3,N,2 2 XIM1 = X(I-1)-X(I) 1 Warning: Array reference at (1) out of bounds (2 > 1) in loop beginning at (2) scipy/fftpack/src/fftpack/cosqf.f:33:25: DO 103 I=3,N,2 2 XIM1 = X(I-1)-X(I) 1 Warning: Array reference at (1) out of bounds (3 > 1) in loop beginning at (2) scipy/fftpack/src/fftpack/cosqf.f:34:11: scipy/fftpack/src/fftpack/cosqf.f:32:72: DO 103 I=3,N,2 2 scipy/fftpack/src/fftpack/cosqf.f:34:11: X(I) = X(I-1)+X(I) 1 Warning: Array reference at (1) out of bounds (3 > 1) in loop beginning at (2) scipy/fftpack/src/fftpack/cosqf.f:34:18: scipy/fftpack/src/fftpack/cosqf.f:32:72: DO 103 I=3,N,2 2 scipy/fftpack/src/fftpack/cosqf.f:34:18: X(I) = X(I-1)+X(I) 1 Warning: Array reference at (1) out of bounds (2 > 1) in loop beginning at (2) scipy/fftpack/src/fftpack/cosqf.f:34:25: scipy/fftpack/src/fftpack/cosqf.f:32:72: DO 103 I=3,N,2 2 scipy/fftpack/src/fftpack/cosqf.f:34:25: X(I) = X(I-1)+X(I) 1 Warning: Array reference at (1) out of bounds (3 > 1) in loop beginning at (2) scipy/fftpack/src/fftpack/cosqf.f:35:11: scipy/fftpack/src/fftpack/cosqf.f:32:72: DO 103 I=3,N,2 2 scipy/fftpack/src/fftpack/cosqf.f:35:11: X(I-1) = XIM1 1 Warning: Array reference at (1) out of bounds (2 > 1) in loop beginning at (2) gfortran:f77: scipy/fftpack/src/fftpack/cfftf.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/fftpack/src/fftpack/cosqi.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/fftpack/src/fftpack/cffti1.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/fftpack/src/fftpack/sinqf.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/fftpack/src/fftpack/sinqi.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/fftpack/src/fftpack/cfftb.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/fftpack/src/fftpack/sint1.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/fftpack/src/fftpack/rfftb.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/fftpack/src/fftpack/rfftb1.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/fftpack/src/fftpack/sinti.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/fftpack/src/fftpack/cfftf1.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/fftpack/src/fftpack/rffti1.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/fftpack/src/fftpack/rfftf1.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/fftpack/src/fftpack/cfftb1.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/fftpack/src/fftpack/cost.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/fftpack/src/fftpack/cosqb.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran scipy/fftpack/src/fftpack/cosqb.f:21:18: DO 101 I=3,N,2 2 XIM1 = X(I-1)+X(I) 1 Warning: Array reference at (1) out of bounds (2 > 1) in loop beginning at (2) scipy/fftpack/src/fftpack/cosqb.f:21:25: DO 101 I=3,N,2 2 XIM1 = X(I-1)+X(I) 1 Warning: Array reference at (1) out of bounds (3 > 1) in loop beginning at (2) scipy/fftpack/src/fftpack/cosqb.f:22:11: scipy/fftpack/src/fftpack/cosqb.f:20:72: DO 101 I=3,N,2 2 scipy/fftpack/src/fftpack/cosqb.f:22:11: X(I) = X(I)-X(I-1) 1 Warning: Array reference at (1) out of bounds (3 > 1) in loop beginning at (2) scipy/fftpack/src/fftpack/cosqb.f:22:18: scipy/fftpack/src/fftpack/cosqb.f:20:72: DO 101 I=3,N,2 2 scipy/fftpack/src/fftpack/cosqb.f:22:18: X(I) = X(I)-X(I-1) 1 Warning: Array reference at (1) out of bounds (3 > 1) in loop beginning at (2) scipy/fftpack/src/fftpack/cosqb.f:22:23: scipy/fftpack/src/fftpack/cosqb.f:20:72: DO 101 I=3,N,2 2 scipy/fftpack/src/fftpack/cosqb.f:22:23: X(I) = X(I)-X(I-1) 1 Warning: Array reference at (1) out of bounds (2 > 1) in loop beginning at (2) scipy/fftpack/src/fftpack/cosqb.f:23:11: scipy/fftpack/src/fftpack/cosqb.f:20:72: DO 101 I=3,N,2 2 scipy/fftpack/src/fftpack/cosqb.f:23:11: X(I-1) = XIM1 1 Warning: Array reference at (1) out of bounds (2 > 1) in loop beginning at (2) scipy/fftpack/src/fftpack/cosqb.f:31:12: scipy/fftpack/src/fftpack/cosqb.f:29:72: DO 102 K=2,NS2 2 scipy/fftpack/src/fftpack/cosqb.f:31:12: XH(K) = W(K-1)*X(KC)+W(KC-1)*X(K) 1 Warning: Array reference at (1) out of bounds (2 > 1) in loop beginning at (2) scipy/fftpack/src/fftpack/cosqb.f:31:40: scipy/fftpack/src/fftpack/cosqb.f:29:72: DO 102 K=2,NS2 2 scipy/fftpack/src/fftpack/cosqb.f:31:40: XH(K) = W(K-1)*X(KC)+W(KC-1)*X(K) 1 Warning: Array reference at (1) out of bounds (2 > 1) in loop beginning at (2) scipy/fftpack/src/fftpack/cosqb.f:32:27: scipy/fftpack/src/fftpack/cosqb.f:29:72: DO 102 K=2,NS2 2 scipy/fftpack/src/fftpack/cosqb.f:32:27: XH(KC) = W(K-1)*X(K)-W(KC-1)*X(KC) 1 Warning: Array reference at (1) out of bounds (2 > 1) in loop beginning at (2) scipy/fftpack/src/fftpack/cosqb.f:37:11: scipy/fftpack/src/fftpack/cosqb.f:35:72: DO 103 K=2,NS2 2 scipy/fftpack/src/fftpack/cosqb.f:37:11: X(K) = XH(K)+XH(KC) 1 Warning: Array reference at (1) out of bounds (2 > 1) in loop beginning at (2) scipy/fftpack/src/fftpack/cosqb.f:37:19: scipy/fftpack/src/fftpack/cosqb.f:35:72: DO 103 K=2,NS2 2 scipy/fftpack/src/fftpack/cosqb.f:37:19: X(K) = XH(K)+XH(KC) 1 Warning: Array reference at (1) out of bounds (2 > 1) in loop beginning at (2) scipy/fftpack/src/fftpack/cosqb.f:38:20: scipy/fftpack/src/fftpack/cosqb.f:35:72: DO 103 K=2,NS2 2 scipy/fftpack/src/fftpack/cosqb.f:38:20: X(KC) = XH(K)-XH(KC) 1 Warning: Array reference at (1) out of bounds (2 > 1) in loop beginning at (2) gfortran:f77: scipy/fftpack/src/fftpack/sint.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/fftpack/src/fftpack/rffti.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/fftpack/src/fftpack/cffti.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/fftpack/src/fftpack/sinqb.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran ar: adding 23 object files to build/temp.linux-ppc64le-2.7/libfftpack.a building 'mach' library using additional config_fc from setup script for fortran compiler: {'noopt': ('scipy/integrate/setup.py', 1)} customize Gnu95FCompiler compiling Fortran sources Fortran f77 compiler: /usr/bin/gfortran -Wall -g -ffixed-form -fno-second-underscore -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -fPIC -cpp Fortran f90 compiler: /usr/bin/gfortran -Wall -g -fno-second-underscore -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -fPIC -cpp Fortran fix compiler: /usr/bin/gfortran -Wall -g -ffixed-form -fno-second-underscore -Wall -g -fno-second-underscore -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -fPIC -cpp creating build/temp.linux-ppc64le-2.7/scipy/integrate creating build/temp.linux-ppc64le-2.7/scipy/integrate/mach compile options: '-I/usr/lib64/python2.7/site-packages/numpy/core/include -c' gfortran:f77: scipy/integrate/mach/xerror.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran scipy/integrate/mach/xerror.f:1:37: SUBROUTINE XERROR(MESS,NMESS,L1,L2) 1 Warning: Unused dummy argument 'l1' at (1) [-Wunused-dummy-argument] scipy/integrate/mach/xerror.f:1:40: SUBROUTINE XERROR(MESS,NMESS,L1,L2) 1 Warning: Unused dummy argument 'l2' at (1) [-Wunused-dummy-argument] gfortran:f77: scipy/integrate/mach/d1mach.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran ar: adding 2 object files to build/temp.linux-ppc64le-2.7/libmach.a building 'quadpack' library compiling Fortran sources Fortran f77 compiler: /usr/bin/gfortran -Wall -g -ffixed-form -fno-second-underscore -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -fPIC -cpp -O3 -funroll-loops Fortran f90 compiler: /usr/bin/gfortran -Wall -g -fno-second-underscore -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -fPIC -cpp -O3 -funroll-loops Fortran fix compiler: /usr/bin/gfortran -Wall -g -ffixed-form -fno-second-underscore -Wall -g -fno-second-underscore -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -fPIC -cpp -O3 -funroll-loops creating build/temp.linux-ppc64le-2.7/scipy/integrate/quadpack compile options: '-I/usr/lib64/python2.7/site-packages/numpy/core/include -c' gfortran:f77: scipy/integrate/quadpack/dqk41.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/integrate/quadpack/dqagi.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/integrate/quadpack/dqk21.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/integrate/quadpack/dqag.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/integrate/quadpack/dqawse.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/integrate/quadpack/dqagie.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran scipy/integrate/quadpack/dqagie.f:411:0: small = small*0.5d+00 Warning: 'small' may be used uninitialized in this function [-Wmaybe-uninitialized] scipy/integrate/quadpack/dqagie.f:372:0: 40 if(ierro.eq.3.or.erlarg.le.ertest) go to 60 Warning: 'ertest' may be used uninitialized in this function [-Wmaybe-uninitialized] scipy/integrate/quadpack/dqagie.f:362:0: erlarg = erlarg-erlast Warning: 'erlarg' may be used uninitialized in this function [-Wmaybe-uninitialized] gfortran:f77: scipy/integrate/quadpack/dqcheb.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/integrate/quadpack/dqk15w.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/integrate/quadpack/dqelg.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/integrate/quadpack/dqc25s.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/integrate/quadpack/dqc25f.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran scipy/integrate/quadpack/dqc25f.f:103:0: integer i,iers,integr,isym,j,k,ksave,m,momcom,neval,maxp1, Warning: 'm' may be used uninitialized in this function [-Wmaybe-uninitialized] gfortran:f77: scipy/integrate/quadpack/dqawoe.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran scipy/integrate/quadpack/dqawoe.f:449:0: 70 if(ierro.eq.3.or.erlarg.le.ertest) go to 90 Warning: 'ertest' may be used uninitialized in this function [-Wmaybe-uninitialized] scipy/integrate/quadpack/dqawoe.f:428:0: erlarg = erlarg-erlast Warning: 'erlarg' may be used uninitialized in this function [-Wmaybe-uninitialized] scipy/integrate/quadpack/dqawoe.f:505:0: if(ierro.eq.3) abserr = abserr+correc Warning: 'correc' may be used uninitialized in this function [-Wmaybe-uninitialized] gfortran:f77: scipy/integrate/quadpack/dqk15i.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/integrate/quadpack/dqwgtf.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran scipy/integrate/quadpack/dqwgtf.f:1:49: double precision function dqwgtf(x,omega,p2,p3,p4,integr) 1 Warning: Unused dummy argument 'p2' at (1) [-Wunused-dummy-argument] scipy/integrate/quadpack/dqwgtf.f:1:52: double precision function dqwgtf(x,omega,p2,p3,p4,integr) 1 Warning: Unused dummy argument 'p3' at (1) [-Wunused-dummy-argument] scipy/integrate/quadpack/dqwgtf.f:1:55: double precision function dqwgtf(x,omega,p2,p3,p4,integr) 1 Warning: Unused dummy argument 'p4' at (1) [-Wunused-dummy-argument] gfortran:f77: scipy/integrate/quadpack/dqk15.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/integrate/quadpack/dqwgts.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/integrate/quadpack/dqwgtc.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran scipy/integrate/quadpack/dqwgtc.f:1:54: double precision function dqwgtc(x,c,p2,p3,p4,kp) 1 Warning: Unused dummy argument 'kp' at (1) [-Wunused-dummy-argument] scipy/integrate/quadpack/dqwgtc.f:1:45: double precision function dqwgtc(x,c,p2,p3,p4,kp) 1 Warning: Unused dummy argument 'p2' at (1) [-Wunused-dummy-argument] scipy/integrate/quadpack/dqwgtc.f:1:48: double precision function dqwgtc(x,c,p2,p3,p4,kp) 1 Warning: Unused dummy argument 'p3' at (1) [-Wunused-dummy-argument] scipy/integrate/quadpack/dqwgtc.f:1:51: double precision function dqwgtc(x,c,p2,p3,p4,kp) 1 Warning: Unused dummy argument 'p4' at (1) [-Wunused-dummy-argument] gfortran:f77: scipy/integrate/quadpack/dqk61.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/integrate/quadpack/dqk51.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/integrate/quadpack/dqawf.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/integrate/quadpack/dqawc.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/integrate/quadpack/dqags.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/integrate/quadpack/dqc25c.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/integrate/quadpack/dqaws.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/integrate/quadpack/dqagse.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran scipy/integrate/quadpack/dqagse.f:376:0: if(dabs(blist(maxerr)-alist(maxerr)).gt.small) go to 90 Warning: 'small' may be used uninitialized in this function [-Wmaybe-uninitialized] scipy/integrate/quadpack/dqagse.f:363:0: 40 if(ierro.eq.3.or.erlarg.le.ertest) go to 60 Warning: 'ertest' may be used uninitialized in this function [-Wmaybe-uninitialized] scipy/integrate/quadpack/dqagse.f:353:0: erlarg = erlarg-erlast Warning: 'erlarg' may be used uninitialized in this function [-Wmaybe-uninitialized] scipy/integrate/quadpack/dqagse.f:418:0: if(ierro.eq.3) abserr = abserr+correc Warning: 'correc' may be used uninitialized in this function [-Wmaybe-uninitialized] gfortran:f77: scipy/integrate/quadpack/dqagpe.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran scipy/integrate/quadpack/dqagpe.f:524:0: if(ierro.eq.3) abserr = abserr+correc Warning: 'correc' may be used uninitialized in this function [-Wmaybe-uninitialized] scipy/integrate/quadpack/dqagpe.f:350:0: iord(k) = iord(i) Warning: 'k' may be used uninitialized in this function [-Wmaybe-uninitialized] gfortran:f77: scipy/integrate/quadpack/dqawfe.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran scipy/integrate/quadpack/dqawfe.f:267:10: 10 l = dabs(omega) 1 Warning: Possible change of value in conversion from REAL(8) to INTEGER(4) at (1) [-Wconversion] scipy/integrate/quadpack/dqawfe.f:358:0: if(ier.ge.1.and.ier.ne.7) abserr = abserr+drl Warning: 'drl' may be used uninitialized in this function [-Wmaybe-uninitialized] scipy/integrate/quadpack/dqawfe.f:316:0: 20 psum(numrl2) = psum(ll)+rslst(lst) Warning: 'll' may be used uninitialized in this function [-Wmaybe-uninitialized] gfortran:f77: scipy/integrate/quadpack/dqawo.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/integrate/quadpack/dqage.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/integrate/quadpack/dqk31.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/integrate/quadpack/dqpsrt.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/integrate/quadpack/dqagp.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/integrate/quadpack/dqawce.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/integrate/quadpack/dqng.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/integrate/quadpack/dqmomo.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran scipy/integrate/quadpack/dqmomo.f:126:5: 90 return 1 Warning: Label 90 at (1) defined but not used [-Wunused-label] ar: adding 35 object files to build/temp.linux-ppc64le-2.7/libquadpack.a building 'lsoda' library compiling Fortran sources Fortran f77 compiler: /usr/bin/gfortran -Wall -g -ffixed-form -fno-second-underscore -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -fPIC -cpp -O3 -funroll-loops Fortran f90 compiler: /usr/bin/gfortran -Wall -g -fno-second-underscore -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -fPIC -cpp -O3 -funroll-loops Fortran fix compiler: /usr/bin/gfortran -Wall -g -ffixed-form -fno-second-underscore -Wall -g -fno-second-underscore -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -fPIC -cpp -O3 -funroll-loops creating build/temp.linux-ppc64le-2.7/scipy/integrate/odepack compile options: '-I/usr/lib64/python2.7/site-packages/numpy/core/include -c' gfortran:f77: scipy/integrate/odepack/blkdta000.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/integrate/odepack/bnorm.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/integrate/odepack/cfode.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/integrate/odepack/ewset.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/integrate/odepack/fnorm.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/integrate/odepack/intdy.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/integrate/odepack/lsoda.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran scipy/integrate/odepack/lsoda.f:1428:0: if (ihit) t = tcrit Warning: 'ihit' may be used uninitialized in this function [-Wmaybe-uninitialized] gfortran:f77: scipy/integrate/odepack/prja.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/integrate/odepack/solsy.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran scipy/integrate/odepack/solsy.f:1:39: subroutine solsy (wm, iwm, x, tem) 1 Warning: Unused dummy argument 'tem' at (1) [-Wunused-dummy-argument] gfortran:f77: scipy/integrate/odepack/srcma.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/integrate/odepack/stoda.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/integrate/odepack/vmnorm.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/integrate/odepack/xerrwv.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran scipy/integrate/odepack/xerrwv.f:1:40: subroutine xerrwv (msg, nmes, nerr, level, ni, i1, i2, nr, r1, r2) 1 Warning: Unused dummy argument 'nerr' at (1) [-Wunused-dummy-argument] gfortran:f77: scipy/integrate/odepack/xsetf.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/integrate/odepack/xsetun.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran ar: adding 15 object files to build/temp.linux-ppc64le-2.7/liblsoda.a building 'vode' library compiling Fortran sources Fortran f77 compiler: /usr/bin/gfortran -Wall -g -ffixed-form -fno-second-underscore -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -fPIC -cpp -O3 -funroll-loops Fortran f90 compiler: /usr/bin/gfortran -Wall -g -fno-second-underscore -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -fPIC -cpp -O3 -funroll-loops Fortran fix compiler: /usr/bin/gfortran -Wall -g -ffixed-form -fno-second-underscore -Wall -g -fno-second-underscore -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -fPIC -cpp -O3 -funroll-loops compile options: '-I/usr/lib64/python2.7/site-packages/numpy/core/include -c' gfortran:f77: scipy/integrate/odepack/vode.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran scipy/integrate/odepack/vode.f:2373:4: 700 R = ONE/TQ(2) 1 Warning: Label 700 at (1) defined but not used [-Wunused-label] scipy/integrate/odepack/vode.f:3522:40: SUBROUTINE XERRWD (MSG, NMES, NERR, LEVEL, NI, I1, I2, NR, R1, R2) 1 Warning: Unused dummy argument 'nerr' at (1) [-Wunused-dummy-argument] scipy/integrate/odepack/vode.f:3503:44: DOUBLE PRECISION FUNCTION D1MACH (IDUM) 1 Warning: Unused dummy argument 'idum' at (1) [-Wunused-dummy-argument] scipy/integrate/odepack/vode.f:2740:35: 1 F, JAC, PDUM, NFLAG, RPAR, IPAR) 1 Warning: Unused dummy argument 'pdum' at (1) [-Wunused-dummy-argument] scipy/integrate/odepack/vode.f:2739:42: SUBROUTINE DVNLSD (Y, YH, LDYH, VSAV, SAVF, EWT, ACOR, IWM, WM, 1 Warning: Unused dummy argument 'vsav' at (1) [-Wunused-dummy-argument] scipy/integrate/odepack/vode.f:3618:0: INTEGER FUNCTION IXSAV (IPAR, IVALUE, ISET) Warning: '__result_ixsav' may be used uninitialized in this function [-Wmaybe-uninitialized] scipy/integrate/odepack/vode.f:1487:0: IF (IHIT) T = TCRIT Warning: 'ihit' may be used uninitialized in this function [-Wmaybe-uninitialized] gfortran:f77: scipy/integrate/odepack/zvode.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran scipy/integrate/odepack/zvode.f:2394:4: 700 R = ONE/TQ(2) 1 Warning: Label 700 at (1) defined but not used [-Wunused-label] scipy/integrate/odepack/zvode.f:2761:35: 1 F, JAC, PDUM, NFLAG, RPAR, IPAR) 1 Warning: Unused dummy argument 'pdum' at (1) [-Wunused-dummy-argument] scipy/integrate/odepack/zvode.f:2760:42: SUBROUTINE ZVNLSD (Y, YH, LDYH, VSAV, SAVF, EWT, ACOR, IWM, WM, 1 Warning: Unused dummy argument 'vsav' at (1) [-Wunused-dummy-argument] scipy/integrate/odepack/zvode.f:1502:0: IF (IHIT) T = TCRIT Warning: 'ihit' may be used uninitialized in this function [-Wmaybe-uninitialized] ar: adding 2 object files to build/temp.linux-ppc64le-2.7/libvode.a building 'dop' library compiling Fortran sources Fortran f77 compiler: /usr/bin/gfortran -Wall -g -ffixed-form -fno-second-underscore -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -fPIC -cpp -O3 -funroll-loops Fortran f90 compiler: /usr/bin/gfortran -Wall -g -fno-second-underscore -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -fPIC -cpp -O3 -funroll-loops Fortran fix compiler: /usr/bin/gfortran -Wall -g -ffixed-form -fno-second-underscore -Wall -g -fno-second-underscore -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -fPIC -cpp -O3 -funroll-loops creating build/temp.linux-ppc64le-2.7/scipy/integrate/dop compile options: '-I/usr/lib64/python2.7/site-packages/numpy/core/include -c' gfortran:f77: scipy/integrate/dop/dop853.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran scipy/integrate/dop/dop853.f:364:42: & SOLOUT,IOUT,IDID,NMAX,UROUND,METH,NSTIFF,SAFE,BETA,FAC1,FAC2, 1 Warning: Unused dummy argument 'meth' at (1) [-Wunused-dummy-argument] scipy/integrate/dop/dop853.f:791:38: FUNCTION HINIT853(N,FCN,X,Y,XEND,POSNEG,F0,F1,Y1,IORD, 1 Warning: Unused dummy argument 'xend' at (1) [-Wunused-dummy-argument] scipy/integrate/dop/dop853.f:686:0: NONSTI=NONSTI+1 Warning: 'nonsti' may be used uninitialized in this function [-Wmaybe-uninitialized] gfortran:f77: scipy/integrate/dop/dopri5.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran scipy/integrate/dop/dopri5.f:558:35: FUNCTION HINIT(N,FCN,X,Y,XEND,POSNEG,F0,F1,Y1,IORD, 1 Warning: Unused dummy argument 'xend' at (1) [-Wunused-dummy-argument] scipy/integrate/dop/dopri5.f:491:0: NONSTI=NONSTI+1 Warning: 'nonsti' may be used uninitialized in this function [-Wmaybe-uninitialized] ar: adding 2 object files to build/temp.linux-ppc64le-2.7/libdop.a building 'fitpack' library compiling Fortran sources Fortran f77 compiler: /usr/bin/gfortran -Wall -g -ffixed-form -fno-second-underscore -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -fPIC -cpp -O3 -funroll-loops Fortran f90 compiler: /usr/bin/gfortran -Wall -g -fno-second-underscore -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -fPIC -cpp -O3 -funroll-loops Fortran fix compiler: /usr/bin/gfortran -Wall -g -ffixed-form -fno-second-underscore -Wall -g -fno-second-underscore -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -fPIC -cpp -O3 -funroll-loops creating build/temp.linux-ppc64le-2.7/scipy/interpolate creating build/temp.linux-ppc64le-2.7/scipy/interpolate/fitpack compile options: '-I/usr/lib64/python2.7/site-packages/numpy/core/include -c' gfortran:f77: scipy/interpolate/fitpack/pogrid.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/interpolate/fitpack/fpdeno.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/interpolate/fitpack/insert.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/interpolate/fitpack/parcur.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/interpolate/fitpack/fpched.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/interpolate/fitpack/fpknot.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran scipy/interpolate/fitpack/fpknot.f:41:0: ihalf = maxpt/2+1 Warning: 'maxpt' may be used uninitialized in this function [-Wmaybe-uninitialized] scipy/interpolate/fitpack/fpknot.f:42:0: nrx = maxbeg+ihalf Warning: 'maxbeg' may be used uninitialized in this function [-Wmaybe-uninitialized] scipy/interpolate/fitpack/fpknot.f:43:0: next = number+1 Warning: 'number' may be used uninitialized in this function [-Wmaybe-uninitialized] gfortran:f77: scipy/interpolate/fitpack/fppocu.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/interpolate/fitpack/fpcyt1.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/interpolate/fitpack/splint.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/interpolate/fitpack/bispeu.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/interpolate/fitpack/fpopsp.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/interpolate/fitpack/fpgrsp.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran scipy/interpolate/fitpack/fpgrsp.f:17:0: real*8 arg,co,dr01,dr02,dr03,dr11,dr12,dr13,fac,fac0,fac1,pinv,piv Warning: 'pinv' may be used uninitialized in this function [-Wmaybe-uninitialized] gfortran:f77: scipy/interpolate/fitpack/fporde.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/interpolate/fitpack/fpintb.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran scipy/interpolate/fitpack/fpintb.f:113:0: if(ib.lt.ia) go to 130 Warning: 'ia' may be used uninitialized in this function [-Wmaybe-uninitialized] gfortran:f77: scipy/interpolate/fitpack/parder.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/interpolate/fitpack/fpsphe.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran scipy/interpolate/fitpack/fpsphe.f:519:0: if(ntt.le.4) iband4 = ncof Warning: 'ntt' may be used uninitialized in this function [-Wmaybe-uninitialized] scipy/interpolate/fitpack/fpsphe.f:614:0: if(il.ne.3 .and. il.ne.nt4) go to 750 Warning: 'nt4' may be used uninitialized in this function [-Wmaybe-uninitialized] scipy/interpolate/fitpack/fpsphe.f:23:0: * l3,l4,ncof,ncoff,npp,np4,nreg,nrint,nrr,nr1,ntt,nt4,nt6,num, Warning: 'np4' may be used uninitialized in this function [-Wmaybe-uninitialized] scipy/interpolate/fitpack/fpsphe.f:746:0: 925 ier = lwest Warning: 'lwest' may be used uninitialized in this function [-Wmaybe-uninitialized] scipy/interpolate/fitpack/fpsphe.f:21:0: integer i,iband,iband1,iband3,iband4,ich1,ich3,ii,ij,il,in,irot, Warning: 'iband1' may be used uninitialized in this function [-Wmaybe-uninitialized] scipy/interpolate/fitpack/fpsphe.f:510:0: f3 = fpms Warning: 'fpms' may be used uninitialized in this function [-Wmaybe-uninitialized] scipy/interpolate/fitpack/fpsphe.f:730:0: if((f1-f2).gt.acc) go to 905 Warning: 'acc' may be used uninitialized in this function [-Wmaybe-uninitialized] gfortran:f77: scipy/interpolate/fitpack/cualde.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/interpolate/fitpack/fpsuev.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/interpolate/fitpack/fourco.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/interpolate/fitpack/fprota.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/interpolate/fitpack/fpader.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/interpolate/fitpack/spgrid.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/interpolate/fitpack/fpsurf.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran scipy/interpolate/fitpack/fpsurf.f:22:0: * nrint,num,num1,nx,nxe,nxx,ny,nye,nyy,n1,rank Warning: 'nyy' may be used uninitialized in this function [-Wmaybe-uninitialized] scipy/interpolate/fitpack/fpsurf.f:21:0: * la,lf,lh,lwest,lx,ly,l1,l2,n,ncof,nk1x,nk1y,nminx,nminy,nreg, Warning: 'nk1y' may be used uninitialized in this function [-Wmaybe-uninitialized] scipy/interpolate/fitpack/fpsurf.f:21:0: Warning: 'nk1x' may be used uninitialized in this function [-Wmaybe-uninitialized] scipy/interpolate/fitpack/fpsurf.f:621:0: 780 ier = lwest Warning: 'lwest' may be used uninitialized in this function [-Wmaybe-uninitialized] scipy/interpolate/fitpack/fpsurf.f:19:0: integer i,iband,iband1,iband3,iband4,ibb,ichang,ich1,ich3,ii, Warning: 'iband1' may be used uninitialized in this function [-Wmaybe-uninitialized] scipy/interpolate/fitpack/fpsurf.f:425:0: f3 = fpms Warning: 'fpms' may be used uninitialized in this function [-Wmaybe-uninitialized] scipy/interpolate/fitpack/fpsurf.f:605:0: if((f1-f2).gt.acc) go to 750 Warning: 'acc' may be used uninitialized in this function [-Wmaybe-uninitialized] gfortran:f77: scipy/interpolate/fitpack/polar.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/interpolate/fitpack/fpadpo.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/interpolate/fitpack/fprpsp.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/interpolate/fitpack/fpgrpa.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/interpolate/fitpack/splder.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/interpolate/fitpack/concon.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/interpolate/fitpack/curfit.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/interpolate/fitpack/fpcons.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran scipy/interpolate/fitpack/fpcons.f:224:35: if(fpold-fp.gt.acc) npl1 = rn*fpms/(fpold-fp) 1 Warning: Possible change of value in conversion from REAL(8) to INTEGER(4) at (1) [-Wconversion] scipy/interpolate/fitpack/fpcons.f:225:0: nplus = min0(nplus*2,max0(npl1,nplus/2,1)) Warning: 'nplus' may be used uninitialized in this function [-Wmaybe-uninitialized] scipy/interpolate/fitpack/fpcons.f:264:0: if(n.eq.nmax) go to 25 Warning: 'nmax' may be used uninitialized in this function [-Wmaybe-uninitialized] scipy/interpolate/fitpack/fpcons.f:383:0: if(u(it).lt.t(l) .or. l.gt.nk1) go to 310 Warning: 'nk1' may be used uninitialized in this function [-Wmaybe-uninitialized] scipy/interpolate/fitpack/fpcons.f:81:0: t(i) = u(j) Warning: 'mm' may be used uninitialized in this function [-Wmaybe-uninitialized] scipy/interpolate/fitpack/fpcons.f:195:0: fpint(n-1) = fpold Warning: 'fpold' may be used uninitialized in this function [-Wmaybe-uninitialized] scipy/interpolate/fitpack/fpcons.f:301:0: f3 = fpms Warning: 'fpms' may be used uninitialized in this function [-Wmaybe-uninitialized] scipy/interpolate/fitpack/fpcons.f:194:0: fpint(n) = fp0 Warning: 'fp0' may be used uninitialized in this function [-Wmaybe-uninitialized] scipy/interpolate/fitpack/fpcons.f:418:0: if((f1-f2).gt.acc) go to 345 Warning: 'acc' may be used uninitialized in this function [-Wmaybe-uninitialized] gfortran:f77: scipy/interpolate/fitpack/evapol.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/interpolate/fitpack/fpsysy.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/interpolate/fitpack/fpopdi.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/interpolate/fitpack/fppola.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran scipy/interpolate/fitpack/fppola.f:24:0: * l3,l4,ncof,ncoff,nvv,nv4,nreg,nrint,nrr,nr1,nuu,nu4,num,num1, Warning: 'nv4' may be used uninitialized in this function [-Wmaybe-uninitialized] scipy/interpolate/fitpack/fppola.f:680:0: if(il.eq.nu4 .and. iopt3.ne.0) go to 760 Warning: 'nu4' may be used uninitialized in this function [-Wmaybe-uninitialized] scipy/interpolate/fitpack/fppola.f:821:0: 925 ier = lwest Warning: 'lwest' may be used uninitialized in this function [-Wmaybe-uninitialized] scipy/interpolate/fitpack/fppola.f:25:0: * numin,nvmin,rank,iband1 Warning: 'iband1' may be used uninitialized in this function [-Wmaybe-uninitialized] scipy/interpolate/fitpack/fppola.f:565:0: f3 = fpms Warning: 'fpms' may be used uninitialized in this function [-Wmaybe-uninitialized] scipy/interpolate/fitpack/fppola.f:805:0: if((f1-f2).gt.acc) go to 905 Warning: 'acc' may be used uninitialized in this function [-Wmaybe-uninitialized] gfortran:f77: scipy/interpolate/fitpack/fpbisp.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/interpolate/fitpack/surev.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/interpolate/fitpack/fpseno.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/interpolate/fitpack/fpbacp.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/interpolate/fitpack/fpchep.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/interpolate/fitpack/fpgrdi.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran scipy/interpolate/fitpack/fpgrdi.f:16:0: real*8 arg,co,dz1,dz2,dz3,fac,fac0,pinv,piv,si,term,one,three,half Warning: 'pinv' may be used uninitialized in this function [-Wmaybe-uninitialized] gfortran:f77: scipy/interpolate/fitpack/fpcuro.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/interpolate/fitpack/fptrpe.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran scipy/interpolate/fitpack/fptrpe.f:64:0: h(j) = b(n1,j)*pinv Warning: 'pinv' may be used uninitialized in this function [-Wmaybe-uninitialized] gfortran:f77: scipy/interpolate/fitpack/clocur.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/interpolate/fitpack/fpinst.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/interpolate/fitpack/fpadno.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/interpolate/fitpack/fpbspl.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/interpolate/fitpack/curev.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/interpolate/fitpack/fpbfout.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran scipy/interpolate/fitpack/fpbfout.f:117:0: c2 = (hc(5)-hc(4))*term Warning: 'term' may be used uninitialized in this function [-Wmaybe-uninitialized] gfortran:f77: scipy/interpolate/fitpack/concur.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/interpolate/fitpack/fpcsin.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/interpolate/fitpack/fpfrno.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran scipy/interpolate/fitpack/fpfrno.f:42:0: right(k) = count Warning: 'k' may be used uninitialized in this function [-Wmaybe-uninitialized] gfortran:f77: scipy/interpolate/fitpack/fpperi.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran scipy/interpolate/fitpack/fpperi.f:339:35: if(fpold-fp.gt.acc) npl1 = rn*fpms/(fpold-fp) 1 Warning: Possible change of value in conversion from REAL(8) to INTEGER(4) at (1) [-Wconversion] scipy/interpolate/fitpack/fpperi.f:340:0: nplus = min0(nplus*2,max0(npl1,nplus/2,1)) Warning: 'nplus' may be used uninitialized in this function [-Wmaybe-uninitialized] scipy/interpolate/fitpack/fpperi.f:375:0: if(n.eq.nmax) go to 5 Warning: 'nmax' may be used uninitialized in this function [-Wmaybe-uninitialized] scipy/interpolate/fitpack/fpperi.f:468:0: if(l0.eq.n10) go to 400 Warning: 'n10' may be used uninitialized in this function [-Wmaybe-uninitialized] scipy/interpolate/fitpack/fpperi.f:16:0: integer i,ich1,ich3,ij,ik,it,iter,i1,i2,i3,j,jk,jper,j1,j2,kk, Warning: 'i1' may be used uninitialized in this function [-Wmaybe-uninitialized] scipy/interpolate/fitpack/fpperi.f:315:0: fpint(n-1) = fpold Warning: 'fpold' may be used uninitialized in this function [-Wmaybe-uninitialized] scipy/interpolate/fitpack/fpperi.f:409:0: f3 = fpms Warning: 'fpms' may be used uninitialized in this function [-Wmaybe-uninitialized] scipy/interpolate/fitpack/fpperi.f:407:0: f1 = fp0-s Warning: 'fp0' may be used uninitialized in this function [-Wmaybe-uninitialized] scipy/interpolate/fitpack/fpperi.f:574:0: if((f1-f2) .gt. acc) go to 585 Warning: 'acc' may be used uninitialized in this function [-Wmaybe-uninitialized] gfortran:f77: scipy/interpolate/fitpack/fpcyt2.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/interpolate/fitpack/fpregr.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran scipy/interpolate/fitpack/fpregr.f:246:33: if(reducx.gt.acc) npl1 = rn*fpms/reducx 1 Warning: Possible change of value in conversion from REAL(8) to INTEGER(4) at (1) [-Wconversion] scipy/interpolate/fitpack/fpregr.f:253:33: if(reducy.gt.acc) npl1 = rn*fpms/reducy 1 Warning: Possible change of value in conversion from REAL(8) to INTEGER(4) at (1) [-Wconversion] scipy/interpolate/fitpack/fpregr.f:310:0: f3 = fpms Warning: 'fpms' may be used uninitialized in this function [-Wmaybe-uninitialized] scipy/interpolate/fitpack/fpregr.f:282:0: if(ny.eq.nye) go to 250 Warning: 'nye' may be used uninitialized in this function [-Wmaybe-uninitialized] scipy/interpolate/fitpack/fpregr.f:269:0: if(nx.eq.nxe) go to 250 Warning: 'nxe' may be used uninitialized in this function [-Wmaybe-uninitialized] scipy/interpolate/fitpack/fpregr.f:225:0: if(nx.eq.nmaxx .and. ny.eq.nmaxy) go to 430 Warning: 'nmaxy' may be used uninitialized in this function [-Wmaybe-uninitialized] scipy/interpolate/fitpack/fpregr.f:225:0: Warning: 'nmaxx' may be used uninitialized in this function [-Wmaybe-uninitialized] scipy/interpolate/fitpack/fpregr.f:341:0: if((f1-f2).gt.acc) go to 330 Warning: 'acc' may be used uninitialized in this function [-Wmaybe-uninitialized] gfortran:f77: scipy/interpolate/fitpack/sproot.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/interpolate/fitpack/fpchec.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/interpolate/fitpack/parsur.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/interpolate/fitpack/cocosp.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/interpolate/fitpack/fpcosp.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/interpolate/fitpack/fppara.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran scipy/interpolate/fitpack/fppara.f:202:35: if(fpold-fp.gt.acc) npl1 = rn*fpms/(fpold-fp) 1 Warning: Possible change of value in conversion from REAL(8) to INTEGER(4) at (1) [-Wconversion] scipy/interpolate/fitpack/fppara.f:203:0: nplus = min0(nplus*2,max0(npl1,nplus/2,1)) Warning: 'nplus' may be used uninitialized in this function [-Wmaybe-uninitialized] scipy/interpolate/fitpack/fppara.f:242:0: if(n.eq.nmax) go to 10 Warning: 'nmax' may be used uninitialized in this function [-Wmaybe-uninitialized] scipy/interpolate/fitpack/fppara.f:175:0: fpint(n-1) = fpold Warning: 'fpold' may be used uninitialized in this function [-Wmaybe-uninitialized] scipy/interpolate/fitpack/fppara.f:279:0: f3 = fpms Warning: 'fpms' may be used uninitialized in this function [-Wmaybe-uninitialized] scipy/interpolate/fitpack/fppara.f:174:0: fpint(n) = fp0 Warning: 'fp0' may be used uninitialized in this function [-Wmaybe-uninitialized] scipy/interpolate/fitpack/fppara.f:378:0: if((f1-f2).gt.acc) go to 345 Warning: 'acc' may be used uninitialized in this function [-Wmaybe-uninitialized] gfortran:f77: scipy/interpolate/fitpack/fptrnp.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran scipy/interpolate/fitpack/fptrnp.f:53:0: h(j) = b(n1,j)*pinv Warning: 'pinv' may be used uninitialized in this function [-Wmaybe-uninitialized] gfortran:f77: scipy/interpolate/fitpack/fpcoco.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/interpolate/fitpack/profil.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/interpolate/fitpack/fprank.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/interpolate/fitpack/regrid.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/interpolate/fitpack/fpgivs.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/interpolate/fitpack/splev.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/interpolate/fitpack/pardeu.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/interpolate/fitpack/fpdisc.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/interpolate/fitpack/fpgrre.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran scipy/interpolate/fitpack/fpgrre.f:199:0: h(j) = by(n1,j)*pinv Warning: 'pinv' may be used uninitialized in this function [-Wmaybe-uninitialized] gfortran:f77: scipy/interpolate/fitpack/bispev.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/interpolate/fitpack/surfit.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/interpolate/fitpack/spalde.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/interpolate/fitpack/dblint.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/interpolate/fitpack/fprppo.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran scipy/interpolate/fitpack/fprppo.f:12:0: integer i,iopt,ii,j,k,l,nu4,nvv Warning: 'j' may be used uninitialized in this function [-Wmaybe-uninitialized] gfortran:f77: scipy/interpolate/fitpack/fprati.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/interpolate/fitpack/fpcurf.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran scipy/interpolate/fitpack/fpcurf.f:186:35: if(fpold-fp.gt.acc) npl1 = rn*fpms/(fpold-fp) 1 Warning: Possible change of value in conversion from REAL(8) to INTEGER(4) at (1) [-Wconversion] scipy/interpolate/fitpack/fpcurf.f:187:0: nplus = min0(nplus*2,max0(npl1,nplus/2,1)) Warning: 'nplus' may be used uninitialized in this function [-Wmaybe-uninitialized] scipy/interpolate/fitpack/fpcurf.f:219:0: if(n.eq.nmax) go to 10 Warning: 'nmax' may be used uninitialized in this function [-Wmaybe-uninitialized] scipy/interpolate/fitpack/fpcurf.f:163:0: fpint(n-1) = fpold Warning: 'fpold' may be used uninitialized in this function [-Wmaybe-uninitialized] scipy/interpolate/fitpack/fpcurf.f:256:0: f3 = fpms Warning: 'fpms' may be used uninitialized in this function [-Wmaybe-uninitialized] scipy/interpolate/fitpack/fpcurf.f:162:0: fpint(n) = fp0 Warning: 'fp0' may be used uninitialized in this function [-Wmaybe-uninitialized] scipy/interpolate/fitpack/fpcurf.f:335:0: if((f1-f2).gt.acc) go to 345 Warning: 'acc' may be used uninitialized in this function [-Wmaybe-uninitialized] gfortran:f77: scipy/interpolate/fitpack/fpback.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/interpolate/fitpack/fppogr.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran scipy/interpolate/fitpack/fppogr.f:286:33: if(reducu.gt.acc) npl1 = rn*fpms/reducu 1 Warning: Possible change of value in conversion from REAL(8) to INTEGER(4) at (1) [-Wconversion] scipy/interpolate/fitpack/fppogr.f:293:33: if(reducv.gt.acc) npl1 = rn*fpms/reducv 1 Warning: Possible change of value in conversion from REAL(8) to INTEGER(4) at (1) [-Wconversion] scipy/interpolate/fitpack/fppogr.f:353:0: f3 = fpms Warning: 'fpms' may be used uninitialized in this function [-Wmaybe-uninitialized] scipy/interpolate/fitpack/fppogr.f:385:0: if((f1-f2).gt.acc) go to 330 Warning: 'acc' may be used uninitialized in this function [-Wmaybe-uninitialized] scipy/interpolate/fitpack/fppogr.f:260:0: if(nu.eq.numax .and. nv.eq.nvmax) go to 430 Warning: 'nvmax' may be used uninitialized in this function [-Wmaybe-uninitialized] scipy/interpolate/fitpack/fppogr.f:315:0: 230 if(nv.eq.nve) go to 210 Warning: 'nve' may be used uninitialized in this function [-Wmaybe-uninitialized] scipy/interpolate/fitpack/fppogr.f:260:0: if(nu.eq.numax .and. nv.eq.nvmax) go to 430 Warning: 'numax' may be used uninitialized in this function [-Wmaybe-uninitialized] scipy/interpolate/fitpack/fppogr.f:312:0: if(nu.eq.nue) go to 270 Warning: 'nue' may be used uninitialized in this function [-Wmaybe-uninitialized] gfortran:f77: scipy/interpolate/fitpack/fpspgr.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran scipy/interpolate/fitpack/fpspgr.f:315:33: if(reducu.gt.acc) npl1 = rn*fpms/reducu 1 Warning: Possible change of value in conversion from REAL(8) to INTEGER(4) at (1) [-Wconversion] scipy/interpolate/fitpack/fpspgr.f:322:33: if(reducv.gt.acc) npl1 = rn*fpms/reducv 1 Warning: Possible change of value in conversion from REAL(8) to INTEGER(4) at (1) [-Wconversion] scipy/interpolate/fitpack/fpspgr.f:382:0: f3 = fpms Warning: 'fpms' may be used uninitialized in this function [-Wmaybe-uninitialized] scipy/interpolate/fitpack/fpspgr.f:414:0: if((f1-f2).gt.acc) go to 330 Warning: 'acc' may be used uninitialized in this function [-Wmaybe-uninitialized] scipy/interpolate/fitpack/fpspgr.f:287:0: if(nu.eq.numax .and. nv.eq.nvmax) go to 430 Warning: 'nvmax' may be used uninitialized in this function [-Wmaybe-uninitialized] scipy/interpolate/fitpack/fpspgr.f:344:0: 230 if(nv.eq.nve) go to 210 Warning: 'nve' may be used uninitialized in this function [-Wmaybe-uninitialized] scipy/interpolate/fitpack/fpspgr.f:287:0: if(nu.eq.numax .and. nv.eq.nvmax) go to 430 Warning: 'numax' may be used uninitialized in this function [-Wmaybe-uninitialized] scipy/interpolate/fitpack/fpspgr.f:341:0: if(nu.eq.nue) go to 270 Warning: 'nue' may be used uninitialized in this function [-Wmaybe-uninitialized] gfortran:f77: scipy/interpolate/fitpack/fpclos.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran scipy/interpolate/fitpack/fpclos.f:395:35: if(fpold-fp.gt.acc) npl1 = rn*fpms/(fpold-fp) 1 Warning: Possible change of value in conversion from REAL(8) to INTEGER(4) at (1) [-Wconversion] scipy/interpolate/fitpack/fpclos.f:396:0: nplus = min0(nplus*2,max0(npl1,nplus/2,1)) Warning: 'nplus' may be used uninitialized in this function [-Wmaybe-uninitialized] scipy/interpolate/fitpack/fpclos.f:438:0: if(n.eq.nmax) go to 5 Warning: 'nmax' may be used uninitialized in this function [-Wmaybe-uninitialized] scipy/interpolate/fitpack/fpclos.f:16:0: integer i,ich1,ich3,ij,ik,it,iter,i1,i2,i3,j,jj,jk,jper,j1,j2,kk, Warning: 'i1' may be used uninitialized in this function [-Wmaybe-uninitialized] scipy/interpolate/fitpack/fpclos.f:363:0: fpint(n-1) = fpold Warning: 'fpold' may be used uninitialized in this function [-Wmaybe-uninitialized] scipy/interpolate/fitpack/fpclos.f:472:0: f3 = fpms Warning: 'fpms' may be used uninitialized in this function [-Wmaybe-uninitialized] scipy/interpolate/fitpack/fpclos.f:470:0: f1 = fp0-s Warning: 'fp0' may be used uninitialized in this function [-Wmaybe-uninitialized] scipy/interpolate/fitpack/fpclos.f:663:0: if((f1-f2) .gt. acc) go to 585 Warning: 'acc' may be used uninitialized in this function [-Wmaybe-uninitialized] gfortran:f77: scipy/interpolate/fitpack/fppasu.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran scipy/interpolate/fitpack/fppasu.f:272:33: if(reducu.gt.acc) npl1 = rn*fpms/reducu 1 Warning: Possible change of value in conversion from REAL(8) to INTEGER(4) at (1) [-Wconversion] scipy/interpolate/fitpack/fppasu.f:279:33: if(reducv.gt.acc) npl1 = rn*fpms/reducv 1 Warning: Possible change of value in conversion from REAL(8) to INTEGER(4) at (1) [-Wconversion] scipy/interpolate/fitpack/fppasu.f:336:0: f3 = fpms Warning: 'fpms' may be used uninitialized in this function [-Wmaybe-uninitialized] scipy/interpolate/fitpack/fppasu.f:308:0: if(nv.eq.nve) go to 250 Warning: 'nve' may be used uninitialized in this function [-Wmaybe-uninitialized] scipy/interpolate/fitpack/fppasu.f:295:0: if(nu.eq.nue) go to 250 Warning: 'nue' may be used uninitialized in this function [-Wmaybe-uninitialized] scipy/interpolate/fitpack/fppasu.f:251:0: if(nu.eq.nmaxu .and. nv.eq.nmaxv) go to 430 Warning: 'nmaxv' may be used uninitialized in this function [-Wmaybe-uninitialized] scipy/interpolate/fitpack/fppasu.f:251:0: Warning: 'nmaxu' may be used uninitialized in this function [-Wmaybe-uninitialized] scipy/interpolate/fitpack/fppasu.f:367:0: if((f1-f2).gt.acc) go to 330 Warning: 'acc' may be used uninitialized in this function [-Wmaybe-uninitialized] scipy/interpolate/fitpack/fppasu.f:230:0: tv(l2) = tv(l4)-perv Warning: 'perv' may be used uninitialized in this function [-Wmaybe-uninitialized] scipy/interpolate/fitpack/fppasu.f:209:0: tu(l3) = tu(l1)+peru Warning: 'peru' may be used uninitialized in this function [-Wmaybe-uninitialized] gfortran:f77: scipy/interpolate/fitpack/percur.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/interpolate/fitpack/sphere.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran ar: adding 50 object files to build/temp.linux-ppc64le-2.7/libfitpack.a ar: adding 35 object files to build/temp.linux-ppc64le-2.7/libfitpack.a building 'fwrappers' library compiling Fortran sources Fortran f77 compiler: /usr/bin/gfortran -Wall -g -ffixed-form -fno-second-underscore -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -fPIC -cpp -O3 -funroll-loops Fortran f90 compiler: /usr/bin/gfortran -Wall -g -fno-second-underscore -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -fPIC -cpp -O3 -funroll-loops Fortran fix compiler: /usr/bin/gfortran -Wall -g -ffixed-form -fno-second-underscore -Wall -g -fno-second-underscore -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -fPIC -cpp -O3 -funroll-loops creating build/temp.linux-ppc64le-2.7/scipy/linalg creating build/temp.linux-ppc64le-2.7/builddir creating build/temp.linux-ppc64le-2.7/builddir/build creating build/temp.linux-ppc64le-2.7/builddir/build/BUILD creating build/temp.linux-ppc64le-2.7/builddir/build/BUILD/scipy-1.0.0 creating build/temp.linux-ppc64le-2.7/builddir/build/BUILD/scipy-1.0.0/scipy creating build/temp.linux-ppc64le-2.7/builddir/build/BUILD/scipy-1.0.0/scipy/_build_utils creating build/temp.linux-ppc64le-2.7/builddir/build/BUILD/scipy-1.0.0/scipy/_build_utils/src compile options: '-I/usr/lib64/python2.7/site-packages/numpy/core/include -I/usr/include/python2.7 -I/usr/include/python2.7 -I/usr/lib64/python2.7/site-packages/numpy/core/include -c' gfortran:f77: scipy/linalg/_blas_subroutine_wrappers.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/linalg/_lapack_subroutine_wrappers.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: /builddir/build/BUILD/scipy-1.0.0/scipy/_build_utils/src/wrap_dummy_g77_abi.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: /builddir/build/BUILD/scipy-1.0.0/scipy/_build_utils/src/wrap_dummy_accelerate.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran ar: adding 4 object files to build/temp.linux-ppc64le-2.7/libfwrappers.a building 'odrpack' library compiling Fortran sources Fortran f77 compiler: /usr/bin/gfortran -Wall -g -ffixed-form -fno-second-underscore -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -fPIC -cpp -O3 -funroll-loops Fortran f90 compiler: /usr/bin/gfortran -Wall -g -fno-second-underscore -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -fPIC -cpp -O3 -funroll-loops Fortran fix compiler: /usr/bin/gfortran -Wall -g -ffixed-form -fno-second-underscore -Wall -g -fno-second-underscore -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -fPIC -cpp -O3 -funroll-loops creating build/temp.linux-ppc64le-2.7/scipy/odr creating build/temp.linux-ppc64le-2.7/scipy/odr/odrpack compile options: '-I/usr/lib64/python2.7/site-packages/numpy/core/include -c' gfortran:f77: scipy/odr/odrpack/d_odr.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran scipy/odr/odrpack/d_odr.f:1014:13: NETA = MAX(TWO,P5-LOG10(ETA)) 1 Warning: Possible change of value in conversion from REAL(8) to INTEGER(4) at (1) [-Wconversion] scipy/odr/odrpack/d_odr.f:2955:13: NTOL = MAX(ONE,P5-LOG10(TOL)) 1 Warning: Possible change of value in conversion from REAL(8) to INTEGER(4) at (1) [-Wconversion] scipy/odr/odrpack/d_odr.f:6032:16: J = WORK(WRK3+I) - 1 1 Warning: Possible change of value in conversion from REAL(8) to INTEGER(4) at (1) [-Wconversion] gfortran:f77: scipy/odr/odrpack/d_mprec.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/odr/odrpack/dlunoc.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/odr/odrpack/d_lpk.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran ar: adding 4 object files to build/temp.linux-ppc64le-2.7/libodrpack.a building 'minpack' library compiling Fortran sources Fortran f77 compiler: /usr/bin/gfortran -Wall -g -ffixed-form -fno-second-underscore -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -fPIC -cpp -O3 -funroll-loops Fortran f90 compiler: /usr/bin/gfortran -Wall -g -fno-second-underscore -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -fPIC -cpp -O3 -funroll-loops Fortran fix compiler: /usr/bin/gfortran -Wall -g -ffixed-form -fno-second-underscore -Wall -g -fno-second-underscore -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -fPIC -cpp -O3 -funroll-loops creating build/temp.linux-ppc64le-2.7/scipy/optimize creating build/temp.linux-ppc64le-2.7/scipy/optimize/minpack compile options: '-I/usr/lib64/python2.7/site-packages/numpy/core/include -c' gfortran:f77: scipy/optimize/minpack/dogleg.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/optimize/minpack/qform.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/optimize/minpack/hybrj.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/optimize/minpack/fdjac2.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/optimize/minpack/lmstr.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/optimize/minpack/qrfac.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/optimize/minpack/enorm.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/optimize/minpack/r1updt.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/optimize/minpack/r1mpyq.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/optimize/minpack/lmpar.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/optimize/minpack/lmdif.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/optimize/minpack/qrsolv.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/optimize/minpack/hybrd1.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/optimize/minpack/chkder.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/optimize/minpack/lmstr1.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/optimize/minpack/fdjac1.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/optimize/minpack/dpmpar.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/optimize/minpack/lmdif1.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/optimize/minpack/lmder.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/optimize/minpack/hybrj1.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/optimize/minpack/lmder1.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/optimize/minpack/hybrd.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/optimize/minpack/rwupdt.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran ar: adding 23 object files to build/temp.linux-ppc64le-2.7/libminpack.a building 'rootfind' library compiling C sources C compiler: gcc -pthread -fno-strict-aliasing -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -D_GNU_SOURCE -fPIC -fwrapv -DNDEBUG -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -D_GNU_SOURCE -fPIC -fwrapv -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -fPIC creating build/temp.linux-ppc64le-2.7/scipy/optimize/Zeros compile options: '-I/usr/lib64/python2.7/site-packages/numpy/core/include -c' gcc: scipy/optimize/Zeros/bisect.c gcc: scipy/optimize/Zeros/brenth.c gcc: scipy/optimize/Zeros/ridder.c gcc: scipy/optimize/Zeros/brentq.c ar: adding 4 object files to build/temp.linux-ppc64le-2.7/librootfind.a building 'superlu_src' library compiling C sources C compiler: gcc -pthread -fno-strict-aliasing -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -D_GNU_SOURCE -fPIC -fwrapv -DNDEBUG -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -D_GNU_SOURCE -fPIC -fwrapv -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -fPIC creating build/temp.linux-ppc64le-2.7/scipy/sparse creating build/temp.linux-ppc64le-2.7/scipy/sparse/linalg creating build/temp.linux-ppc64le-2.7/scipy/sparse/linalg/dsolve creating build/temp.linux-ppc64le-2.7/scipy/sparse/linalg/dsolve/SuperLU creating build/temp.linux-ppc64le-2.7/scipy/sparse/linalg/dsolve/SuperLU/SRC compile options: '-DUSE_VENDOR_BLAS=1 -Iscipy/sparse/linalg/dsolve/SuperLU/SRC -I/usr/lib64/python2.7/site-packages/numpy/core/include -c' gcc: scipy/sparse/linalg/dsolve/SuperLU/SRC/smemory.c scipy/sparse/linalg/dsolve/SuperLU/SRC/smemory.c: In function 'sLUMemXpand': scipy/sparse/linalg/dsolve/SuperLU/SRC/smemory.c:453:5: warning: enumeration value 'LLVL' not handled in switch [-Wswitch] switch ( mem_type ) { ^~~~~~ scipy/sparse/linalg/dsolve/SuperLU/SRC/smemory.c:453:5: warning: enumeration value 'ULVL' not handled in switch [-Wswitch] gcc: scipy/sparse/linalg/dsolve/SuperLU/SRC/cgstrf.c gcc: scipy/sparse/linalg/dsolve/SuperLU/SRC/zgsisx.c scipy/sparse/linalg/dsolve/SuperLU/SRC/zgsisx.c: In function 'zgsisx': scipy/sparse/linalg/dsolve/SuperLU/SRC/zgsisx.c:588:7: warning: suggest parentheses around operand of '!' or change '&' to '&&' or '!' to '~' [-Wparentheses] if ( !mc64 & equil ) { /* Only perform equilibration, no row perm */ ^~~~~ scipy/sparse/linalg/dsolve/SuperLU/SRC/zgsisx.c:677:24: warning: unused variable 'rhs_work' [-Wunused-variable] doublecomplex *rhs_work; ^~~~~~~~ scipy/sparse/linalg/dsolve/SuperLU/SRC/zgsisx.c:423:15: warning: variable 'diag_pivot_thresh' set but not used [-Wunused-but-set-variable] double diag_pivot_thresh; ^~~~~~~~~~~~~~~~~ In file included from scipy/sparse/linalg/dsolve/SuperLU/SRC/slu_zdefs.h:101, from scipy/sparse/linalg/dsolve/SuperLU/SRC/zgsisx.c:22: scipy/sparse/linalg/dsolve/SuperLU/SRC/slu_util.h:95:46: warning: 'smlnum' may be used uninitialized in this function [-Wmaybe-uninitialized] #define SUPERLU_MAX(x, y) ( (x) > (y) ? (x) : (y) ) ^ scipy/sparse/linalg/dsolve/SuperLU/SRC/zgsisx.c:421:36: note: 'smlnum' was declared here double amax, anorm, bignum, smlnum, colcnd, rowcnd, rcmax, rcmin; ^~~~~~ In file included from scipy/sparse/linalg/dsolve/SuperLU/SRC/slu_zdefs.h:101, from scipy/sparse/linalg/dsolve/SuperLU/SRC/zgsisx.c:22: scipy/sparse/linalg/dsolve/SuperLU/SRC/slu_util.h:96:46: warning: 'bignum' may be used uninitialized in this function [-Wmaybe-uninitialized] #define SUPERLU_MIN(x, y) ( (x) < (y) ? (x) : (y) ) ^ scipy/sparse/linalg/dsolve/SuperLU/SRC/zgsisx.c:421:28: note: 'bignum' was declared here double amax, anorm, bignum, smlnum, colcnd, rowcnd, rcmax, rcmin; ^~~~~~ gcc: scipy/sparse/linalg/dsolve/SuperLU/SRC/dpanel_dfs.c gcc: scipy/sparse/linalg/dsolve/SuperLU/SRC/ssp_blas3.c gcc: scipy/sparse/linalg/dsolve/SuperLU/SRC/dlangs.c scipy/sparse/linalg/dsolve/SuperLU/SRC/dlangs.c: In function 'dlangs': scipy/sparse/linalg/dsolve/SuperLU/SRC/dlangs.c:126:12: warning: 'value' may be used uninitialized in this function [-Wmaybe-uninitialized] return (value); ^ gcc: scipy/sparse/linalg/dsolve/SuperLU/SRC/csnode_bmod.c scipy/sparse/linalg/dsolve/SuperLU/SRC/csnode_bmod.c: In function 'csnode_bmod': scipy/sparse/linalg/dsolve/SuperLU/SRC/csnode_bmod.c:63:35: warning: unused variable 'iptr' [-Wunused-variable] int isub, irow, i, iptr; ^~~~ scipy/sparse/linalg/dsolve/SuperLU/SRC/csnode_bmod.c:63:32: warning: unused variable 'i' [-Wunused-variable] int isub, irow, i, iptr; ^ gcc: scipy/sparse/linalg/dsolve/SuperLU/SRC/dlaqgs.c gcc: scipy/sparse/linalg/dsolve/SuperLU/SRC/zsnode_dfs.c scipy/sparse/linalg/dsolve/SuperLU/SRC/zsnode_dfs.c: In function 'zsnode_dfs': scipy/sparse/linalg/dsolve/SuperLU/SRC/zsnode_dfs.c:91:12: warning: suggest parentheses around assignment used as truth value [-Wparentheses] if ( mem_error = zLUMemXpand(jcol, nextl, LSUB, &nzlmax, Glu) ) ^~~~~~~~~ scipy/sparse/linalg/dsolve/SuperLU/SRC/zsnode_dfs.c:104:11: warning: suggest parentheses around assignment used as truth value [-Wparentheses] if ( mem_error = zLUMemXpand(jcol, nextl, LSUB, &nzlmax, Glu) ) ^~~~~~~~~ gcc: scipy/sparse/linalg/dsolve/SuperLU/SRC/zpanel_bmod.c gcc: scipy/sparse/linalg/dsolve/SuperLU/SRC/dmemory.c scipy/sparse/linalg/dsolve/SuperLU/SRC/dmemory.c: In function 'dLUMemXpand': scipy/sparse/linalg/dsolve/SuperLU/SRC/dmemory.c:453:5: warning: enumeration value 'LLVL' not handled in switch [-Wswitch] switch ( mem_type ) { ^~~~~~ scipy/sparse/linalg/dsolve/SuperLU/SRC/dmemory.c:453:5: warning: enumeration value 'ULVL' not handled in switch [-Wswitch] gcc: scipy/sparse/linalg/dsolve/SuperLU/SRC/zgscon.c gcc: scipy/sparse/linalg/dsolve/SuperLU/SRC/memory.c gcc: scipy/sparse/linalg/dsolve/SuperLU/SRC/relax_snode.c gcc: scipy/sparse/linalg/dsolve/SuperLU/SRC/creadrb.c scipy/sparse/linalg/dsolve/SuperLU/SRC/creadrb.c: In function 'creadrb': scipy/sparse/linalg/dsolve/SuperLU/SRC/creadrb.c:304:5: warning: ignoring return value of 'fgets', declared with attribute warn_unused_result [-Wunused-result] fgets(buf, 100, fp); ^~~~~~~~~~~~~~~~~~~ scipy/sparse/linalg/dsolve/SuperLU/SRC/creadrb.c:309:9: warning: ignoring return value of 'fscanf', declared with attribute warn_unused_result [-Wunused-result] fscanf(fp, "%14c", buf); buf[14] = 0; ^~~~~~~~~~~~~~~~~~~~~~~ scipy/sparse/linalg/dsolve/SuperLU/SRC/creadrb.c:316:5: warning: ignoring return value of 'fscanf', declared with attribute warn_unused_result [-Wunused-result] fscanf(fp, "%3c", type); ^~~~~~~~~~~~~~~~~~~~~~~ scipy/sparse/linalg/dsolve/SuperLU/SRC/creadrb.c:317:5: warning: ignoring return value of 'fscanf', declared with attribute warn_unused_result [-Wunused-result] fscanf(fp, "%11c", buf); /* pad */ ^~~~~~~~~~~~~~~~~~~~~~~ scipy/sparse/linalg/dsolve/SuperLU/SRC/creadrb.c:323:5: warning: ignoring return value of 'fscanf', declared with attribute warn_unused_result [-Wunused-result] fscanf(fp, "%14c", buf); sscanf(buf, "%d", nrow); ^~~~~~~~~~~~~~~~~~~~~~~ scipy/sparse/linalg/dsolve/SuperLU/SRC/creadrb.c:324:5: warning: ignoring return value of 'fscanf', declared with attribute warn_unused_result [-Wunused-result] fscanf(fp, "%14c", buf); sscanf(buf, "%d", ncol); ^~~~~~~~~~~~~~~~~~~~~~~ scipy/sparse/linalg/dsolve/SuperLU/SRC/creadrb.c:325:5: warning: ignoring return value of 'fscanf', declared with attribute warn_unused_result [-Wunused-result] fscanf(fp, "%14c", buf); sscanf(buf, "%d", nonz); ^~~~~~~~~~~~~~~~~~~~~~~ scipy/sparse/linalg/dsolve/SuperLU/SRC/creadrb.c:326:5: warning: ignoring return value of 'fscanf', declared with attribute warn_unused_result [-Wunused-result] fscanf(fp, "%14c", buf); sscanf(buf, "%d", &tmp); ^~~~~~~~~~~~~~~~~~~~~~~ scipy/sparse/linalg/dsolve/SuperLU/SRC/creadrb.c:338:5: warning: ignoring return value of 'fscanf', declared with attribute warn_unused_result [-Wunused-result] fscanf(fp, "%16c", buf); ^~~~~~~~~~~~~~~~~~~~~~~ scipy/sparse/linalg/dsolve/SuperLU/SRC/creadrb.c:340:5: warning: ignoring return value of 'fscanf', declared with attribute warn_unused_result [-Wunused-result] fscanf(fp, "%16c", buf); ^~~~~~~~~~~~~~~~~~~~~~~ scipy/sparse/linalg/dsolve/SuperLU/SRC/creadrb.c:342:5: warning: ignoring return value of 'fscanf', declared with attribute warn_unused_result [-Wunused-result] fscanf(fp, "%20c", buf); ^~~~~~~~~~~~~~~~~~~~~~~ scipy/sparse/linalg/dsolve/SuperLU/SRC/creadrb.c: In function 'ReadVector': scipy/sparse/linalg/dsolve/SuperLU/SRC/creadrb.c:142:9: warning: ignoring return value of 'fgets', declared with attribute warn_unused_result [-Wunused-result] fgets(buf, 100, fp); /* read a line at a time */ ^~~~~~~~~~~~~~~~~~~ scipy/sparse/linalg/dsolve/SuperLU/SRC/creadrb.c: In function 'cReadValues': scipy/sparse/linalg/dsolve/SuperLU/SRC/creadrb.c:164:2: warning: ignoring return value of 'fgets', declared with attribute warn_unused_result [-Wunused-result] fgets(buf, 100, fp); /* read a line at a time */ ^~~~~~~~~~~~~~~~~~~ gcc: scipy/sparse/linalg/dsolve/SuperLU/SRC/ilu_ssnode_dfs.c gcc: scipy/sparse/linalg/dsolve/SuperLU/SRC/dcomplex.c gcc: scipy/sparse/linalg/dsolve/SuperLU/SRC/zgsrfs.c gcc: scipy/sparse/linalg/dsolve/SuperLU/SRC/spruneL.c gcc: scipy/sparse/linalg/dsolve/SuperLU/SRC/scomplex.c gcc: scipy/sparse/linalg/dsolve/SuperLU/SRC/slacon2.c scipy/sparse/linalg/dsolve/SuperLU/SRC/slacon2.c: In function 'slacon2_': scipy/sparse/linalg/dsolve/SuperLU/SRC/slacon2.c:160:16: warning: implicit declaration of function 'idamax_'; did you mean 'isamax_'? [-Wimplicit-function-declaration] isave[1] = idamax_(n, &x[0], &c__1); /* j */ ^~~~~~~ isamax_ gcc: scipy/sparse/linalg/dsolve/SuperLU/SRC/cmemory.c scipy/sparse/linalg/dsolve/SuperLU/SRC/cmemory.c: In function 'cLUMemXpand': scipy/sparse/linalg/dsolve/SuperLU/SRC/cmemory.c:453:5: warning: enumeration value 'LLVL' not handled in switch [-Wswitch] switch ( mem_type ) { ^~~~~~ scipy/sparse/linalg/dsolve/SuperLU/SRC/cmemory.c:453:5: warning: enumeration value 'ULVL' not handled in switch [-Wswitch] gcc: scipy/sparse/linalg/dsolve/SuperLU/SRC/sreadrb.c scipy/sparse/linalg/dsolve/SuperLU/SRC/sreadrb.c: In function 'sreadrb': scipy/sparse/linalg/dsolve/SuperLU/SRC/sreadrb.c:295:5: warning: ignoring return value of 'fgets', declared with attribute warn_unused_result [-Wunused-result] fgets(buf, 100, fp); ^~~~~~~~~~~~~~~~~~~ scipy/sparse/linalg/dsolve/SuperLU/SRC/sreadrb.c:300:9: warning: ignoring return value of 'fscanf', declared with attribute warn_unused_result [-Wunused-result] fscanf(fp, "%14c", buf); buf[14] = 0; ^~~~~~~~~~~~~~~~~~~~~~~ scipy/sparse/linalg/dsolve/SuperLU/SRC/sreadrb.c:307:5: warning: ignoring return value of 'fscanf', declared with attribute warn_unused_result [-Wunused-result] fscanf(fp, "%3c", type); ^~~~~~~~~~~~~~~~~~~~~~~ scipy/sparse/linalg/dsolve/SuperLU/SRC/sreadrb.c:308:5: warning: ignoring return value of 'fscanf', declared with attribute warn_unused_result [-Wunused-result] fscanf(fp, "%11c", buf); /* pad */ ^~~~~~~~~~~~~~~~~~~~~~~ scipy/sparse/linalg/dsolve/SuperLU/SRC/sreadrb.c:314:5: warning: ignoring return value of 'fscanf', declared with attribute warn_unused_result [-Wunused-result] fscanf(fp, "%14c", buf); sscanf(buf, "%d", nrow); ^~~~~~~~~~~~~~~~~~~~~~~ scipy/sparse/linalg/dsolve/SuperLU/SRC/sreadrb.c:315:5: warning: ignoring return value of 'fscanf', declared with attribute warn_unused_result [-Wunused-result] fscanf(fp, "%14c", buf); sscanf(buf, "%d", ncol); ^~~~~~~~~~~~~~~~~~~~~~~ scipy/sparse/linalg/dsolve/SuperLU/SRC/sreadrb.c:316:5: warning: ignoring return value of 'fscanf', declared with attribute warn_unused_result [-Wunused-result] fscanf(fp, "%14c", buf); sscanf(buf, "%d", nonz); ^~~~~~~~~~~~~~~~~~~~~~~ scipy/sparse/linalg/dsolve/SuperLU/SRC/sreadrb.c:317:5: warning: ignoring return value of 'fscanf', declared with attribute warn_unused_result [-Wunused-result] fscanf(fp, "%14c", buf); sscanf(buf, "%d", &tmp); ^~~~~~~~~~~~~~~~~~~~~~~ scipy/sparse/linalg/dsolve/SuperLU/SRC/sreadrb.c:329:5: warning: ignoring return value of 'fscanf', declared with attribute warn_unused_result [-Wunused-result] fscanf(fp, "%16c", buf); ^~~~~~~~~~~~~~~~~~~~~~~ scipy/sparse/linalg/dsolve/SuperLU/SRC/sreadrb.c:331:5: warning: ignoring return value of 'fscanf', declared with attribute warn_unused_result [-Wunused-result] fscanf(fp, "%16c", buf); ^~~~~~~~~~~~~~~~~~~~~~~ scipy/sparse/linalg/dsolve/SuperLU/SRC/sreadrb.c:333:5: warning: ignoring return value of 'fscanf', declared with attribute warn_unused_result [-Wunused-result] fscanf(fp, "%20c", buf); ^~~~~~~~~~~~~~~~~~~~~~~ scipy/sparse/linalg/dsolve/SuperLU/SRC/sreadrb.c: In function 'ReadVector': scipy/sparse/linalg/dsolve/SuperLU/SRC/sreadrb.c:142:9: warning: ignoring return value of 'fgets', declared with attribute warn_unused_result [-Wunused-result] fgets(buf, 100, fp); /* read a line at a time */ ^~~~~~~~~~~~~~~~~~~ scipy/sparse/linalg/dsolve/SuperLU/SRC/sreadrb.c: In function 'sReadValues': scipy/sparse/linalg/dsolve/SuperLU/SRC/sreadrb.c:163:9: warning: ignoring return value of 'fgets', declared with attribute warn_unused_result [-Wunused-result] fgets(buf, 100, fp); /* read a line at a time */ ^~~~~~~~~~~~~~~~~~~ gcc: scipy/sparse/linalg/dsolve/SuperLU/SRC/sgssvx.c scipy/sparse/linalg/dsolve/SuperLU/SRC/sgssvx.c: In function 'sgssvx': scipy/sparse/linalg/dsolve/SuperLU/SRC/sgssvx.c:377:14: warning: variable 'diag_pivot_thresh' set but not used [-Wunused-but-set-variable] float diag_pivot_thresh; ^~~~~~~~~~~~~~~~~ In file included from scipy/sparse/linalg/dsolve/SuperLU/SRC/slu_sdefs.h:101, from scipy/sparse/linalg/dsolve/SuperLU/SRC/sgssvx.c:22: scipy/sparse/linalg/dsolve/SuperLU/SRC/slu_util.h:95:46: warning: 'smlnum' may be used uninitialized in this function [-Wmaybe-uninitialized] #define SUPERLU_MAX(x, y) ( (x) > (y) ? (x) : (y) ) ^ scipy/sparse/linalg/dsolve/SuperLU/SRC/sgssvx.c:375:35: note: 'smlnum' was declared here float amax, anorm, bignum, smlnum, colcnd, rowcnd, rcmax, rcmin; ^~~~~~ In file included from scipy/sparse/linalg/dsolve/SuperLU/SRC/slu_sdefs.h:101, from scipy/sparse/linalg/dsolve/SuperLU/SRC/sgssvx.c:22: scipy/sparse/linalg/dsolve/SuperLU/SRC/slu_util.h:96:46: warning: 'bignum' may be used uninitialized in this function [-Wmaybe-uninitialized] #define SUPERLU_MIN(x, y) ( (x) < (y) ? (x) : (y) ) ^ scipy/sparse/linalg/dsolve/SuperLU/SRC/sgssvx.c:375:27: note: 'bignum' was declared here float amax, anorm, bignum, smlnum, colcnd, rowcnd, rcmax, rcmin; ^~~~~~ gcc: scipy/sparse/linalg/dsolve/SuperLU/SRC/ilu_dsnode_dfs.c gcc: scipy/sparse/linalg/dsolve/SuperLU/SRC/slaqgs.c gcc: scipy/sparse/linalg/dsolve/SuperLU/SRC/zgstrf.c gcc: scipy/sparse/linalg/dsolve/SuperLU/SRC/scsum1.c scipy/sparse/linalg/dsolve/SuperLU/SRC/scsum1.c: In function 'scsum1_slu': scipy/sparse/linalg/dsolve/SuperLU/SRC/scsum1.c:56:15: warning: variable 'i__2' set but not used [-Wunused-but-set-variable] int i__1, i__2; ^~~~ scipy/sparse/linalg/dsolve/SuperLU/SRC/scsum1.c:56:9: warning: variable 'i__1' set but not used [-Wunused-but-set-variable] int i__1, i__2; ^~~~ gcc: scipy/sparse/linalg/dsolve/SuperLU/SRC/cgssvx.c scipy/sparse/linalg/dsolve/SuperLU/SRC/cgssvx.c: In function 'cgssvx': scipy/sparse/linalg/dsolve/SuperLU/SRC/cgssvx.c:377:14: warning: variable 'diag_pivot_thresh' set but not used [-Wunused-but-set-variable] float diag_pivot_thresh; ^~~~~~~~~~~~~~~~~ In file included from scipy/sparse/linalg/dsolve/SuperLU/SRC/slu_cdefs.h:101, from scipy/sparse/linalg/dsolve/SuperLU/SRC/cgssvx.c:22: scipy/sparse/linalg/dsolve/SuperLU/SRC/slu_util.h:95:46: warning: 'smlnum' may be used uninitialized in this function [-Wmaybe-uninitialized] #define SUPERLU_MAX(x, y) ( (x) > (y) ? (x) : (y) ) ^ scipy/sparse/linalg/dsolve/SuperLU/SRC/cgssvx.c:375:35: note: 'smlnum' was declared here float amax, anorm, bignum, smlnum, colcnd, rowcnd, rcmax, rcmin; ^~~~~~ In file included from scipy/sparse/linalg/dsolve/SuperLU/SRC/slu_cdefs.h:101, from scipy/sparse/linalg/dsolve/SuperLU/SRC/cgssvx.c:22: scipy/sparse/linalg/dsolve/SuperLU/SRC/slu_util.h:96:46: warning: 'bignum' may be used uninitialized in this function [-Wmaybe-uninitialized] #define SUPERLU_MIN(x, y) ( (x) < (y) ? (x) : (y) ) ^ scipy/sparse/linalg/dsolve/SuperLU/SRC/cgssvx.c:375:27: note: 'bignum' was declared here float amax, anorm, bignum, smlnum, colcnd, rowcnd, rcmax, rcmin; ^~~~~~ gcc: scipy/sparse/linalg/dsolve/SuperLU/SRC/zsnode_bmod.c scipy/sparse/linalg/dsolve/SuperLU/SRC/zsnode_bmod.c: In function 'zsnode_bmod': scipy/sparse/linalg/dsolve/SuperLU/SRC/zsnode_bmod.c:63:35: warning: unused variable 'iptr' [-Wunused-variable] int isub, irow, i, iptr; ^~~~ scipy/sparse/linalg/dsolve/SuperLU/SRC/zsnode_bmod.c:63:32: warning: unused variable 'i' [-Wunused-variable] int isub, irow, i, iptr; ^ gcc: scipy/sparse/linalg/dsolve/SuperLU/SRC/zgstrs.c scipy/sparse/linalg/dsolve/SuperLU/SRC/zgstrs.c: In function 'zgstrs': scipy/sparse/linalg/dsolve/SuperLU/SRC/zgstrs.c:108:24: warning: unused variable 'incy' [-Wunused-variable] int incx = 1, incy = 1; ^~~~ scipy/sparse/linalg/dsolve/SuperLU/SRC/zgstrs.c:108:14: warning: unused variable 'incx' [-Wunused-variable] int incx = 1, incy = 1; ^~~~ gcc: scipy/sparse/linalg/dsolve/SuperLU/SRC/zcolumn_bmod.c scipy/sparse/linalg/dsolve/SuperLU/SRC/zcolumn_bmod.c: In function 'zcolumn_bmod': scipy/sparse/linalg/dsolve/SuperLU/SRC/zcolumn_bmod.c:298:6: warning: suggest parentheses around assignment used as truth value [-Wparentheses] if (mem_error = zLUMemXpand(jcol, nextlu, LUSUP, &nzlumax, Glu)) ^~~~~~~~~ gcc: scipy/sparse/linalg/dsolve/SuperLU/SRC/dreadhb.c scipy/sparse/linalg/dsolve/SuperLU/SRC/dreadhb.c: In function 'dreadhb': scipy/sparse/linalg/dsolve/SuperLU/SRC/dreadhb.c:291:29: warning: unused variable 'key' [-Wunused-variable] char buf[100], type[4], key[10]; ^~~ scipy/sparse/linalg/dsolve/SuperLU/SRC/dreadhb.c: In function 'dReadValues': scipy/sparse/linalg/dsolve/SuperLU/SRC/dreadhb.c:167:2: warning: ignoring return value of 'fgets', declared with attribute warn_unused_result [-Wunused-result] fgets(buf, 100, fp); /* read a line at a time */ ^~~~~~~~~~~~~~~~~~~ scipy/sparse/linalg/dsolve/SuperLU/SRC/dreadhb.c: In function 'dreadhb': scipy/sparse/linalg/dsolve/SuperLU/SRC/dreadhb.c:295:5: warning: ignoring return value of 'fgets', declared with attribute warn_unused_result [-Wunused-result] fgets(buf, 100, fp); ^~~~~~~~~~~~~~~~~~~ scipy/sparse/linalg/dsolve/SuperLU/SRC/dreadhb.c:307:2: warning: ignoring return value of 'fscanf', declared with attribute warn_unused_result [-Wunused-result] fscanf(fp, "%14c", buf); buf[14] = 0; ^~~~~~~~~~~~~~~~~~~~~~~ scipy/sparse/linalg/dsolve/SuperLU/SRC/dreadhb.c:315:5: warning: ignoring return value of 'fscanf', declared with attribute warn_unused_result [-Wunused-result] fscanf(fp, "%3c", type); ^~~~~~~~~~~~~~~~~~~~~~~ scipy/sparse/linalg/dsolve/SuperLU/SRC/dreadhb.c:316:5: warning: ignoring return value of 'fscanf', declared with attribute warn_unused_result [-Wunused-result] fscanf(fp, "%11c", buf); /* pad */ ^~~~~~~~~~~~~~~~~~~~~~~ scipy/sparse/linalg/dsolve/SuperLU/SRC/dreadhb.c:322:5: warning: ignoring return value of 'fscanf', declared with attribute warn_unused_result [-Wunused-result] fscanf(fp, "%14c", buf); sscanf(buf, "%d", nrow); ^~~~~~~~~~~~~~~~~~~~~~~ scipy/sparse/linalg/dsolve/SuperLU/SRC/dreadhb.c:323:5: warning: ignoring return value of 'fscanf', declared with attribute warn_unused_result [-Wunused-result] fscanf(fp, "%14c", buf); sscanf(buf, "%d", ncol); ^~~~~~~~~~~~~~~~~~~~~~~ scipy/sparse/linalg/dsolve/SuperLU/SRC/dreadhb.c:324:5: warning: ignoring return value of 'fscanf', declared with attribute warn_unused_result [-Wunused-result] fscanf(fp, "%14c", buf); sscanf(buf, "%d", nonz); ^~~~~~~~~~~~~~~~~~~~~~~ scipy/sparse/linalg/dsolve/SuperLU/SRC/dreadhb.c:325:5: warning: ignoring return value of 'fscanf', declared with attribute warn_unused_result [-Wunused-result] fscanf(fp, "%14c", buf); sscanf(buf, "%d", &tmp); ^~~~~~~~~~~~~~~~~~~~~~~ scipy/sparse/linalg/dsolve/SuperLU/SRC/dreadhb.c:337:5: warning: ignoring return value of 'fscanf', declared with attribute warn_unused_result [-Wunused-result] fscanf(fp, "%16c", buf); ^~~~~~~~~~~~~~~~~~~~~~~ scipy/sparse/linalg/dsolve/SuperLU/SRC/dreadhb.c:339:5: warning: ignoring return value of 'fscanf', declared with attribute warn_unused_result [-Wunused-result] fscanf(fp, "%16c", buf); ^~~~~~~~~~~~~~~~~~~~~~~ scipy/sparse/linalg/dsolve/SuperLU/SRC/dreadhb.c:341:5: warning: ignoring return value of 'fscanf', declared with attribute warn_unused_result [-Wunused-result] fscanf(fp, "%20c", buf); ^~~~~~~~~~~~~~~~~~~~~~~ scipy/sparse/linalg/dsolve/SuperLU/SRC/dreadhb.c:343:5: warning: ignoring return value of 'fscanf', declared with attribute warn_unused_result [-Wunused-result] fscanf(fp, "%20c", buf); ^~~~~~~~~~~~~~~~~~~~~~~ scipy/sparse/linalg/dsolve/SuperLU/SRC/dreadhb.c: In function 'ReadVector': scipy/sparse/linalg/dsolve/SuperLU/SRC/dreadhb.c:147:2: warning: ignoring return value of 'fgets', declared with attribute warn_unused_result [-Wunused-result] fgets(buf, 100, fp); /* read a line at a time */ ^~~~~~~~~~~~~~~~~~~ gcc: scipy/sparse/linalg/dsolve/SuperLU/SRC/cgsrfs.c gcc: scipy/sparse/linalg/dsolve/SuperLU/SRC/ilu_relax_snode.c gcc: scipy/sparse/linalg/dsolve/SuperLU/SRC/dmach.c scipy/sparse/linalg/dsolve/SuperLU/SRC/dmach.c: In function 'dmach': scipy/sparse/linalg/dsolve/SuperLU/SRC/dmach.c:62:9: warning: implicit declaration of function 'strncmp' [-Wimplicit-function-declaration] if (strncmp(cmach, "E", 1)==0) { ^~~~~~~ scipy/sparse/linalg/dsolve/SuperLU/SRC/dmach.c:91:12: warning: 'rmach' may be used uninitialized in this function [-Wmaybe-uninitialized] return rmach; ^~~~~ gcc: scipy/sparse/linalg/dsolve/SuperLU/SRC/sreadtriple.c scipy/sparse/linalg/dsolve/SuperLU/SRC/sreadtriple.c: In function 'sreadtriple': scipy/sparse/linalg/dsolve/SuperLU/SRC/sreadtriple.c:48:5: warning: ignoring return value of 'scanf', declared with attribute warn_unused_result [-Wunused-result] scanf("%d%d", n, nonz); ^~~~~~~~~~~~~~~~~~~~~~ scipy/sparse/linalg/dsolve/SuperLU/SRC/sreadtriple.c:64:2: warning: ignoring return value of 'scanf', declared with attribute warn_unused_result [-Wunused-result] scanf("%d%d%f\n", &row[nz], &col[nz], &val[nz]); ^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ scipy/sparse/linalg/dsolve/SuperLU/SRC/sreadtriple.c: In function 'sreadrhs': scipy/sparse/linalg/dsolve/SuperLU/SRC/sreadtriple.c:146:7: warning: ignoring return value of 'fscanf', declared with attribute warn_unused_result [-Wunused-result] fscanf(fp, "%f\n", &b[i]); ^~~~~~~~~~~~~~~~~~~~~~~~~ gcc: scipy/sparse/linalg/dsolve/SuperLU/SRC/zpivotL.c gcc: scipy/sparse/linalg/dsolve/SuperLU/SRC/clangs.c scipy/sparse/linalg/dsolve/SuperLU/SRC/clangs.c: In function 'clangs': scipy/sparse/linalg/dsolve/SuperLU/SRC/clangs.c:126:12: warning: 'value' may be used uninitialized in this function [-Wmaybe-uninitialized] return (value); ^ gcc: scipy/sparse/linalg/dsolve/SuperLU/SRC/sgsitrf.c gcc: scipy/sparse/linalg/dsolve/SuperLU/SRC/zgsequ.c gcc: scipy/sparse/linalg/dsolve/SuperLU/SRC/icmax1.c scipy/sparse/linalg/dsolve/SuperLU/SRC/icmax1.c: In function 'icmax1_slu': scipy/sparse/linalg/dsolve/SuperLU/SRC/icmax1.c:63:24: warning: variable 'i__2' set but not used [-Wunused-but-set-variable] int ret_val, i__1, i__2; ^~~~ scipy/sparse/linalg/dsolve/SuperLU/SRC/icmax1.c:63:18: warning: variable 'i__1' set but not used [-Wunused-but-set-variable] int ret_val, i__1, i__2; ^~~~ gcc: scipy/sparse/linalg/dsolve/SuperLU/SRC/zreadrb.c scipy/sparse/linalg/dsolve/SuperLU/SRC/zreadrb.c: In function 'zreadrb': scipy/sparse/linalg/dsolve/SuperLU/SRC/zreadrb.c:304:5: warning: ignoring return value of 'fgets', declared with attribute warn_unused_result [-Wunused-result] fgets(buf, 100, fp); ^~~~~~~~~~~~~~~~~~~ scipy/sparse/linalg/dsolve/SuperLU/SRC/zreadrb.c:309:9: warning: ignoring return value of 'fscanf', declared with attribute warn_unused_result [-Wunused-result] fscanf(fp, "%14c", buf); buf[14] = 0; ^~~~~~~~~~~~~~~~~~~~~~~ scipy/sparse/linalg/dsolve/SuperLU/SRC/zreadrb.c:316:5: warning: ignoring return value of 'fscanf', declared with attribute warn_unused_result [-Wunused-result] fscanf(fp, "%3c", type); ^~~~~~~~~~~~~~~~~~~~~~~ scipy/sparse/linalg/dsolve/SuperLU/SRC/zreadrb.c:317:5: warning: ignoring return value of 'fscanf', declared with attribute warn_unused_result [-Wunused-result] fscanf(fp, "%11c", buf); /* pad */ ^~~~~~~~~~~~~~~~~~~~~~~ scipy/sparse/linalg/dsolve/SuperLU/SRC/zreadrb.c:323:5: warning: ignoring return value of 'fscanf', declared with attribute warn_unused_result [-Wunused-result] fscanf(fp, "%14c", buf); sscanf(buf, "%d", nrow); ^~~~~~~~~~~~~~~~~~~~~~~ scipy/sparse/linalg/dsolve/SuperLU/SRC/zreadrb.c:324:5: warning: ignoring return value of 'fscanf', declared with attribute warn_unused_result [-Wunused-result] fscanf(fp, "%14c", buf); sscanf(buf, "%d", ncol); ^~~~~~~~~~~~~~~~~~~~~~~ scipy/sparse/linalg/dsolve/SuperLU/SRC/zreadrb.c:325:5: warning: ignoring return value of 'fscanf', declared with attribute warn_unused_result [-Wunused-result] fscanf(fp, "%14c", buf); sscanf(buf, "%d", nonz); ^~~~~~~~~~~~~~~~~~~~~~~ scipy/sparse/linalg/dsolve/SuperLU/SRC/zreadrb.c:326:5: warning: ignoring return value of 'fscanf', declared with attribute warn_unused_result [-Wunused-result] fscanf(fp, "%14c", buf); sscanf(buf, "%d", &tmp); ^~~~~~~~~~~~~~~~~~~~~~~ scipy/sparse/linalg/dsolve/SuperLU/SRC/zreadrb.c:338:5: warning: ignoring return value of 'fscanf', declared with attribute warn_unused_result [-Wunused-result] fscanf(fp, "%16c", buf); ^~~~~~~~~~~~~~~~~~~~~~~ scipy/sparse/linalg/dsolve/SuperLU/SRC/zreadrb.c:340:5: warning: ignoring return value of 'fscanf', declared with attribute warn_unused_result [-Wunused-result] fscanf(fp, "%16c", buf); ^~~~~~~~~~~~~~~~~~~~~~~ scipy/sparse/linalg/dsolve/SuperLU/SRC/zreadrb.c:342:5: warning: ignoring return value of 'fscanf', declared with attribute warn_unused_result [-Wunused-result] fscanf(fp, "%20c", buf); ^~~~~~~~~~~~~~~~~~~~~~~ scipy/sparse/linalg/dsolve/SuperLU/SRC/zreadrb.c: In function 'ReadVector': scipy/sparse/linalg/dsolve/SuperLU/SRC/zreadrb.c:142:9: warning: ignoring return value of 'fgets', declared with attribute warn_unused_result [-Wunused-result] fgets(buf, 100, fp); /* read a line at a time */ ^~~~~~~~~~~~~~~~~~~ scipy/sparse/linalg/dsolve/SuperLU/SRC/zreadrb.c: In function 'zReadValues': scipy/sparse/linalg/dsolve/SuperLU/SRC/zreadrb.c:164:2: warning: ignoring return value of 'fgets', declared with attribute warn_unused_result [-Wunused-result] fgets(buf, 100, fp); /* read a line at a time */ ^~~~~~~~~~~~~~~~~~~ gcc: scipy/sparse/linalg/dsolve/SuperLU/SRC/qselect.c gcc: scipy/sparse/linalg/dsolve/SuperLU/SRC/util.c scipy/sparse/linalg/dsolve/SuperLU/SRC/util.c: In function 'ilu_countnz': scipy/sparse/linalg/dsolve/SuperLU/SRC/util.c:224:24: warning: variable 'irep' set but not used [-Wunused-but-set-variable] int jlen, irep; ^~~~ gcc: scipy/sparse/linalg/dsolve/SuperLU/SRC/dpivotgrowth.c gcc: scipy/sparse/linalg/dsolve/SuperLU/SRC/zcopy_to_ucol.c scipy/sparse/linalg/dsolve/SuperLU/SRC/zcopy_to_ucol.c: In function 'zcopy_to_ucol': scipy/sparse/linalg/dsolve/SuperLU/SRC/zcopy_to_ucol.c:87:11: warning: suggest parentheses around assignment used as truth value [-Wparentheses] if (mem_error = zLUMemXpand(jcol, nextu, UCOL, &nzumax, Glu)) ^~~~~~~~~ scipy/sparse/linalg/dsolve/SuperLU/SRC/zcopy_to_ucol.c:90:11: warning: suggest parentheses around assignment used as truth value [-Wparentheses] if (mem_error = zLUMemXpand(jcol, nextu, USUB, &nzumax, Glu)) ^~~~~~~~~ gcc: scipy/sparse/linalg/dsolve/SuperLU/SRC/ddiagonal.c gcc: scipy/sparse/linalg/dsolve/SuperLU/SRC/claqgs.c gcc: scipy/sparse/linalg/dsolve/SuperLU/SRC/zdiagonal.c gcc: scipy/sparse/linalg/dsolve/SuperLU/SRC/ccolumn_dfs.c scipy/sparse/linalg/dsolve/SuperLU/SRC/ccolumn_dfs.c: In function 'ccolumn_dfs': scipy/sparse/linalg/dsolve/SuperLU/SRC/ccolumn_dfs.c:139:8: warning: suggest parentheses around assignment used as truth value [-Wparentheses] if ( mem_error = cLUMemXpand(jcol, nextl, LSUB, &nzlmax, Glu) ) ^~~~~~~~~ scipy/sparse/linalg/dsolve/SuperLU/SRC/ccolumn_dfs.c:181:14: warning: suggest parentheses around assignment used as truth value [-Wparentheses] if ( mem_error = ^~~~~~~~~ gcc: scipy/sparse/linalg/dsolve/SuperLU/SRC/superlu_timer.c gcc: scipy/sparse/linalg/dsolve/SuperLU/SRC/smyblas2.c gcc: scipy/sparse/linalg/dsolve/SuperLU/SRC/zutil.c scipy/sparse/linalg/dsolve/SuperLU/SRC/zutil.c: In function 'zFillRHS': scipy/sparse/linalg/dsolve/SuperLU/SRC/zutil.c:370:22: warning: variable 'Aval' set but not used [-Wunused-but-set-variable] doublecomplex *Aval; ^~~~ scipy/sparse/linalg/dsolve/SuperLU/SRC/zutil.c: At top level: scipy/sparse/linalg/dsolve/SuperLU/SRC/zutil.c:478:1: warning: return type defaults to 'int' [-Wimplicit-int] print_doublecomplex_vec(char *what, int n, doublecomplex *vec) ^~~~~~~~~~~~~~~~~~~~~~~ gcc: scipy/sparse/linalg/dsolve/SuperLU/SRC/zgsitrf.c scipy/sparse/linalg/dsolve/SuperLU/SRC/zgsitrf.c: In function 'zgsitrf': scipy/sparse/linalg/dsolve/SuperLU/SRC/zgsitrf.c:251:12: warning: unused variable 'one' [-Wunused-variable] double one = 1.0; ^~~ gcc: scipy/sparse/linalg/dsolve/SuperLU/SRC/izmax1.c scipy/sparse/linalg/dsolve/SuperLU/SRC/izmax1.c: In function 'izmax1_slu': scipy/sparse/linalg/dsolve/SuperLU/SRC/izmax1.c:61:24: warning: variable 'i__2' set but not used [-Wunused-but-set-variable] int ret_val, i__1, i__2; ^~~~ scipy/sparse/linalg/dsolve/SuperLU/SRC/izmax1.c:61:18: warning: variable 'i__1' set but not used [-Wunused-but-set-variable] int ret_val, i__1, i__2; ^~~~ gcc: scipy/sparse/linalg/dsolve/SuperLU/SRC/cutil.c scipy/sparse/linalg/dsolve/SuperLU/SRC/cutil.c: In function 'cFillRHS': scipy/sparse/linalg/dsolve/SuperLU/SRC/cutil.c:370:16: warning: variable 'Aval' set but not used [-Wunused-but-set-variable] complex *Aval; ^~~~ scipy/sparse/linalg/dsolve/SuperLU/SRC/cutil.c: At top level: scipy/sparse/linalg/dsolve/SuperLU/SRC/cutil.c:478:1: warning: return type defaults to 'int' [-Wimplicit-int] print_complex_vec(char *what, int n, complex *vec) ^~~~~~~~~~~~~~~~~ gcc: scipy/sparse/linalg/dsolve/SuperLU/SRC/sp_preorder.c gcc: scipy/sparse/linalg/dsolve/SuperLU/SRC/ilu_dcopy_to_ucol.c gcc: scipy/sparse/linalg/dsolve/SuperLU/SRC/ilu_heap_relax_snode.c gcc: scipy/sparse/linalg/dsolve/SuperLU/SRC/dcopy_to_ucol.c scipy/sparse/linalg/dsolve/SuperLU/SRC/dcopy_to_ucol.c: In function 'dcopy_to_ucol': scipy/sparse/linalg/dsolve/SuperLU/SRC/dcopy_to_ucol.c:87:11: warning: suggest parentheses around assignment used as truth value [-Wparentheses] if (mem_error = dLUMemXpand(jcol, nextu, UCOL, &nzumax, Glu)) ^~~~~~~~~ scipy/sparse/linalg/dsolve/SuperLU/SRC/dcopy_to_ucol.c:90:11: warning: suggest parentheses around assignment used as truth value [-Wparentheses] if (mem_error = dLUMemXpand(jcol, nextu, USUB, &nzumax, Glu)) ^~~~~~~~~ gcc: scipy/sparse/linalg/dsolve/SuperLU/SRC/cdiagonal.c gcc: scipy/sparse/linalg/dsolve/SuperLU/SRC/cpivotL.c gcc: scipy/sparse/linalg/dsolve/SuperLU/SRC/ilu_spanel_dfs.c gcc: scipy/sparse/linalg/dsolve/SuperLU/SRC/dgsitrf.c gcc: scipy/sparse/linalg/dsolve/SuperLU/SRC/dreadtriple.c scipy/sparse/linalg/dsolve/SuperLU/SRC/dreadtriple.c: In function 'dreadtriple': scipy/sparse/linalg/dsolve/SuperLU/SRC/dreadtriple.c:48:5: warning: ignoring return value of 'scanf', declared with attribute warn_unused_result [-Wunused-result] scanf("%d%d", n, nonz); ^~~~~~~~~~~~~~~~~~~~~~ scipy/sparse/linalg/dsolve/SuperLU/SRC/dreadtriple.c:64:2: warning: ignoring return value of 'scanf', declared with attribute warn_unused_result [-Wunused-result] scanf("%d%d%lf\n", &row[nz], &col[nz], &val[nz]); ^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ scipy/sparse/linalg/dsolve/SuperLU/SRC/dreadtriple.c: In function 'dreadrhs': scipy/sparse/linalg/dsolve/SuperLU/SRC/dreadtriple.c:146:7: warning: ignoring return value of 'fscanf', declared with attribute warn_unused_result [-Wunused-result] fscanf(fp, "%lf\n", &b[i]); ^~~~~~~~~~~~~~~~~~~~~~~~~~ gcc: scipy/sparse/linalg/dsolve/SuperLU/SRC/colamd.c gcc: scipy/sparse/linalg/dsolve/SuperLU/SRC/zgssv.c scipy/sparse/linalg/dsolve/SuperLU/SRC/zgssv.c: In function 'zgssv': scipy/sparse/linalg/dsolve/SuperLU/SRC/zgssv.c:210:5: warning: 'AA' may be used uninitialized in this function [-Wmaybe-uninitialized] sp_preorder(options, AA, perm_c, etree, &AC); ^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ gcc: scipy/sparse/linalg/dsolve/SuperLU/SRC/ilu_cpivotL.c gcc: scipy/sparse/linalg/dsolve/SuperLU/SRC/sgsisx.c scipy/sparse/linalg/dsolve/SuperLU/SRC/sgsisx.c: In function 'sgsisx': scipy/sparse/linalg/dsolve/SuperLU/SRC/sgsisx.c:588:7: warning: suggest parentheses around operand of '!' or change '&' to '&&' or '!' to '~' [-Wparentheses] if ( !mc64 & equil ) { /* Only perform equilibration, no row perm */ ^~~~~ scipy/sparse/linalg/dsolve/SuperLU/SRC/sgsisx.c:677:16: warning: unused variable 'rhs_work' [-Wunused-variable] float *rhs_work; ^~~~~~~~ scipy/sparse/linalg/dsolve/SuperLU/SRC/sgsisx.c:423:14: warning: variable 'diag_pivot_thresh' set but not used [-Wunused-but-set-variable] float diag_pivot_thresh; ^~~~~~~~~~~~~~~~~ In file included from scipy/sparse/linalg/dsolve/SuperLU/SRC/slu_sdefs.h:101, from scipy/sparse/linalg/dsolve/SuperLU/SRC/sgsisx.c:22: scipy/sparse/linalg/dsolve/SuperLU/SRC/slu_util.h:95:46: warning: 'smlnum' may be used uninitialized in this function [-Wmaybe-uninitialized] #define SUPERLU_MAX(x, y) ( (x) > (y) ? (x) : (y) ) ^ scipy/sparse/linalg/dsolve/SuperLU/SRC/sgsisx.c:421:35: note: 'smlnum' was declared here float amax, anorm, bignum, smlnum, colcnd, rowcnd, rcmax, rcmin; ^~~~~~ In file included from scipy/sparse/linalg/dsolve/SuperLU/SRC/slu_sdefs.h:101, from scipy/sparse/linalg/dsolve/SuperLU/SRC/sgsisx.c:22: scipy/sparse/linalg/dsolve/SuperLU/SRC/slu_util.h:96:46: warning: 'bignum' may be used uninitialized in this function [-Wmaybe-uninitialized] #define SUPERLU_MIN(x, y) ( (x) < (y) ? (x) : (y) ) ^ scipy/sparse/linalg/dsolve/SuperLU/SRC/sgsisx.c:421:27: note: 'bignum' was declared here float amax, anorm, bignum, smlnum, colcnd, rowcnd, rcmax, rcmin; ^~~~~~ gcc: scipy/sparse/linalg/dsolve/SuperLU/SRC/ssnode_bmod.c scipy/sparse/linalg/dsolve/SuperLU/SRC/ssnode_bmod.c: In function 'ssnode_bmod': scipy/sparse/linalg/dsolve/SuperLU/SRC/ssnode_bmod.c:62:35: warning: unused variable 'iptr' [-Wunused-variable] int isub, irow, i, iptr; ^~~~ scipy/sparse/linalg/dsolve/SuperLU/SRC/ssnode_bmod.c:62:32: warning: unused variable 'i' [-Wunused-variable] int isub, irow, i, iptr; ^ gcc: scipy/sparse/linalg/dsolve/SuperLU/SRC/sreadhb.c scipy/sparse/linalg/dsolve/SuperLU/SRC/sreadhb.c: In function 'sreadhb': scipy/sparse/linalg/dsolve/SuperLU/SRC/sreadhb.c:291:29: warning: unused variable 'key' [-Wunused-variable] char buf[100], type[4], key[10]; ^~~ scipy/sparse/linalg/dsolve/SuperLU/SRC/sreadhb.c: In function 'sReadValues': scipy/sparse/linalg/dsolve/SuperLU/SRC/sreadhb.c:167:2: warning: ignoring return value of 'fgets', declared with attribute warn_unused_result [-Wunused-result] fgets(buf, 100, fp); /* read a line at a time */ ^~~~~~~~~~~~~~~~~~~ scipy/sparse/linalg/dsolve/SuperLU/SRC/sreadhb.c: In function 'sreadhb': scipy/sparse/linalg/dsolve/SuperLU/SRC/sreadhb.c:295:5: warning: ignoring return value of 'fgets', declared with attribute warn_unused_result [-Wunused-result] fgets(buf, 100, fp); ^~~~~~~~~~~~~~~~~~~ scipy/sparse/linalg/dsolve/SuperLU/SRC/sreadhb.c:307:2: warning: ignoring return value of 'fscanf', declared with attribute warn_unused_result [-Wunused-result] fscanf(fp, "%14c", buf); buf[14] = 0; ^~~~~~~~~~~~~~~~~~~~~~~ scipy/sparse/linalg/dsolve/SuperLU/SRC/sreadhb.c:315:5: warning: ignoring return value of 'fscanf', declared with attribute warn_unused_result [-Wunused-result] fscanf(fp, "%3c", type); ^~~~~~~~~~~~~~~~~~~~~~~ scipy/sparse/linalg/dsolve/SuperLU/SRC/sreadhb.c:316:5: warning: ignoring return value of 'fscanf', declared with attribute warn_unused_result [-Wunused-result] fscanf(fp, "%11c", buf); /* pad */ ^~~~~~~~~~~~~~~~~~~~~~~ scipy/sparse/linalg/dsolve/SuperLU/SRC/sreadhb.c:322:5: warning: ignoring return value of 'fscanf', declared with attribute warn_unused_result [-Wunused-result] fscanf(fp, "%14c", buf); sscanf(buf, "%d", nrow); ^~~~~~~~~~~~~~~~~~~~~~~ scipy/sparse/linalg/dsolve/SuperLU/SRC/sreadhb.c:323:5: warning: ignoring return value of 'fscanf', declared with attribute warn_unused_result [-Wunused-result] fscanf(fp, "%14c", buf); sscanf(buf, "%d", ncol); ^~~~~~~~~~~~~~~~~~~~~~~ scipy/sparse/linalg/dsolve/SuperLU/SRC/sreadhb.c:324:5: warning: ignoring return value of 'fscanf', declared with attribute warn_unused_result [-Wunused-result] fscanf(fp, "%14c", buf); sscanf(buf, "%d", nonz); ^~~~~~~~~~~~~~~~~~~~~~~ scipy/sparse/linalg/dsolve/SuperLU/SRC/sreadhb.c:325:5: warning: ignoring return value of 'fscanf', declared with attribute warn_unused_result [-Wunused-result] fscanf(fp, "%14c", buf); sscanf(buf, "%d", &tmp); ^~~~~~~~~~~~~~~~~~~~~~~ scipy/sparse/linalg/dsolve/SuperLU/SRC/sreadhb.c:337:5: warning: ignoring return value of 'fscanf', declared with attribute warn_unused_result [-Wunused-result] fscanf(fp, "%16c", buf); ^~~~~~~~~~~~~~~~~~~~~~~ scipy/sparse/linalg/dsolve/SuperLU/SRC/sreadhb.c:339:5: warning: ignoring return value of 'fscanf', declared with attribute warn_unused_result [-Wunused-result] fscanf(fp, "%16c", buf); ^~~~~~~~~~~~~~~~~~~~~~~ scipy/sparse/linalg/dsolve/SuperLU/SRC/sreadhb.c:341:5: warning: ignoring return value of 'fscanf', declared with attribute warn_unused_result [-Wunused-result] fscanf(fp, "%20c", buf); ^~~~~~~~~~~~~~~~~~~~~~~ scipy/sparse/linalg/dsolve/SuperLU/SRC/sreadhb.c:343:5: warning: ignoring return value of 'fscanf', declared with attribute warn_unused_result [-Wunused-result] fscanf(fp, "%20c", buf); ^~~~~~~~~~~~~~~~~~~~~~~ scipy/sparse/linalg/dsolve/SuperLU/SRC/sreadhb.c: In function 'ReadVector': scipy/sparse/linalg/dsolve/SuperLU/SRC/sreadhb.c:147:2: warning: ignoring return value of 'fgets', declared with attribute warn_unused_result [-Wunused-result] fgets(buf, 100, fp); /* read a line at a time */ ^~~~~~~~~~~~~~~~~~~ gcc: scipy/sparse/linalg/dsolve/SuperLU/SRC/zpruneL.c gcc: scipy/sparse/linalg/dsolve/SuperLU/SRC/sgsequ.c gcc: scipy/sparse/linalg/dsolve/SuperLU/SRC/cgsitrf.c scipy/sparse/linalg/dsolve/SuperLU/SRC/cgsitrf.c: In function 'cgsitrf': scipy/sparse/linalg/dsolve/SuperLU/SRC/cgsitrf.c:251:11: warning: unused variable 'one' [-Wunused-variable] float one = 1.0; ^~~ gcc: scipy/sparse/linalg/dsolve/SuperLU/SRC/ilu_zcolumn_dfs.c gcc: scipy/sparse/linalg/dsolve/SuperLU/SRC/dsnode_dfs.c scipy/sparse/linalg/dsolve/SuperLU/SRC/dsnode_dfs.c: In function 'dsnode_dfs': scipy/sparse/linalg/dsolve/SuperLU/SRC/dsnode_dfs.c:91:12: warning: suggest parentheses around assignment used as truth value [-Wparentheses] if ( mem_error = dLUMemXpand(jcol, nextl, LSUB, &nzlmax, Glu) ) ^~~~~~~~~ scipy/sparse/linalg/dsolve/SuperLU/SRC/dsnode_dfs.c:104:11: warning: suggest parentheses around assignment used as truth value [-Wparentheses] if ( mem_error = dLUMemXpand(jcol, nextl, LSUB, &nzlmax, Glu) ) ^~~~~~~~~ gcc: scipy/sparse/linalg/dsolve/SuperLU/SRC/dgscon.c gcc: scipy/sparse/linalg/dsolve/SuperLU/SRC/dpruneL.c gcc: scipy/sparse/linalg/dsolve/SuperLU/SRC/cldperm.c gcc: scipy/sparse/linalg/dsolve/SuperLU/SRC/scolumn_dfs.c scipy/sparse/linalg/dsolve/SuperLU/SRC/scolumn_dfs.c: In function 'scolumn_dfs': scipy/sparse/linalg/dsolve/SuperLU/SRC/scolumn_dfs.c:139:8: warning: suggest parentheses around assignment used as truth value [-Wparentheses] if ( mem_error = sLUMemXpand(jcol, nextl, LSUB, &nzlmax, Glu) ) ^~~~~~~~~ scipy/sparse/linalg/dsolve/SuperLU/SRC/scolumn_dfs.c:181:14: warning: suggest parentheses around assignment used as truth value [-Wparentheses] if ( mem_error = ^~~~~~~~~ gcc: scipy/sparse/linalg/dsolve/SuperLU/SRC/ilu_dpivotL.c gcc: scipy/sparse/linalg/dsolve/SuperLU/SRC/dutil.c scipy/sparse/linalg/dsolve/SuperLU/SRC/dutil.c: In function 'dFillRHS': scipy/sparse/linalg/dsolve/SuperLU/SRC/dutil.c:368:15: warning: variable 'Aval' set but not used [-Wunused-but-set-variable] double *Aval; ^~~~ scipy/sparse/linalg/dsolve/SuperLU/SRC/dutil.c: At top level: scipy/sparse/linalg/dsolve/SuperLU/SRC/dutil.c:474:1: warning: return type defaults to 'int' [-Wimplicit-int] print_double_vec(char *what, int n, double *vec) ^~~~~~~~~~~~~~~~ gcc: scipy/sparse/linalg/dsolve/SuperLU/SRC/sgsrfs.c gcc: scipy/sparse/linalg/dsolve/SuperLU/SRC/ilu_spivotL.c gcc: scipy/sparse/linalg/dsolve/SuperLU/SRC/zmyblas2.c gcc: scipy/sparse/linalg/dsolve/SuperLU/SRC/sp_ienv.c scipy/sparse/linalg/dsolve/SuperLU/SRC/sp_ienv.c: In function 'sp_ienv': scipy/sparse/linalg/dsolve/SuperLU/SRC/sp_ienv.c:85:5: warning: implicit declaration of function 'input_error' [-Wimplicit-function-declaration] input_error("sp_ienv", &i); ^~~~~~~~~~~ gcc: scipy/sparse/linalg/dsolve/SuperLU/SRC/dgstrf.c gcc: scipy/sparse/linalg/dsolve/SuperLU/SRC/sgscon.c gcc: scipy/sparse/linalg/dsolve/SuperLU/SRC/ilu_zpivotL.c gcc: scipy/sparse/linalg/dsolve/SuperLU/SRC/ilu_dcolumn_dfs.c gcc: scipy/sparse/linalg/dsolve/SuperLU/SRC/dgsisx.c scipy/sparse/linalg/dsolve/SuperLU/SRC/dgsisx.c: In function 'dgsisx': scipy/sparse/linalg/dsolve/SuperLU/SRC/dgsisx.c:588:7: warning: suggest parentheses around operand of '!' or change '&' to '&&' or '!' to '~' [-Wparentheses] if ( !mc64 & equil ) { /* Only perform equilibration, no row perm */ ^~~~~ scipy/sparse/linalg/dsolve/SuperLU/SRC/dgsisx.c:677:17: warning: unused variable 'rhs_work' [-Wunused-variable] double *rhs_work; ^~~~~~~~ scipy/sparse/linalg/dsolve/SuperLU/SRC/dgsisx.c:423:15: warning: variable 'diag_pivot_thresh' set but not used [-Wunused-but-set-variable] double diag_pivot_thresh; ^~~~~~~~~~~~~~~~~ In file included from scipy/sparse/linalg/dsolve/SuperLU/SRC/slu_ddefs.h:101, from scipy/sparse/linalg/dsolve/SuperLU/SRC/dgsisx.c:22: scipy/sparse/linalg/dsolve/SuperLU/SRC/slu_util.h:95:46: warning: 'smlnum' may be used uninitialized in this function [-Wmaybe-uninitialized] #define SUPERLU_MAX(x, y) ( (x) > (y) ? (x) : (y) ) ^ scipy/sparse/linalg/dsolve/SuperLU/SRC/dgsisx.c:421:36: note: 'smlnum' was declared here double amax, anorm, bignum, smlnum, colcnd, rowcnd, rcmax, rcmin; ^~~~~~ In file included from scipy/sparse/linalg/dsolve/SuperLU/SRC/slu_ddefs.h:101, from scipy/sparse/linalg/dsolve/SuperLU/SRC/dgsisx.c:22: scipy/sparse/linalg/dsolve/SuperLU/SRC/slu_util.h:96:46: warning: 'bignum' may be used uninitialized in this function [-Wmaybe-uninitialized] #define SUPERLU_MIN(x, y) ( (x) < (y) ? (x) : (y) ) ^ scipy/sparse/linalg/dsolve/SuperLU/SRC/dgsisx.c:421:28: note: 'bignum' was declared here double amax, anorm, bignum, smlnum, colcnd, rowcnd, rcmax, rcmin; ^~~~~~ gcc: scipy/sparse/linalg/dsolve/SuperLU/SRC/cgsequ.c gcc: scipy/sparse/linalg/dsolve/SuperLU/SRC/sgssv.c scipy/sparse/linalg/dsolve/SuperLU/SRC/sgssv.c: In function 'sgssv': scipy/sparse/linalg/dsolve/SuperLU/SRC/sgssv.c:210:5: warning: 'AA' may be used uninitialized in this function [-Wmaybe-uninitialized] sp_preorder(options, AA, perm_c, etree, &AC); ^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ gcc: scipy/sparse/linalg/dsolve/SuperLU/SRC/dsnode_bmod.c scipy/sparse/linalg/dsolve/SuperLU/SRC/dsnode_bmod.c: In function 'dsnode_bmod': scipy/sparse/linalg/dsolve/SuperLU/SRC/dsnode_bmod.c:62:35: warning: unused variable 'iptr' [-Wunused-variable] int isub, irow, i, iptr; ^~~~ scipy/sparse/linalg/dsolve/SuperLU/SRC/dsnode_bmod.c:62:32: warning: unused variable 'i' [-Wunused-variable] int isub, irow, i, iptr; ^ gcc: scipy/sparse/linalg/dsolve/SuperLU/SRC/zlangs.c scipy/sparse/linalg/dsolve/SuperLU/SRC/zlangs.c: In function 'zlangs': scipy/sparse/linalg/dsolve/SuperLU/SRC/zlangs.c:126:12: warning: 'value' may be used uninitialized in this function [-Wmaybe-uninitialized] return (value); ^ gcc: scipy/sparse/linalg/dsolve/SuperLU/SRC/ilu_scolumn_dfs.c gcc: scipy/sparse/linalg/dsolve/SuperLU/SRC/csp_blas2.c scipy/sparse/linalg/dsolve/SuperLU/SRC/csp_blas2.c: In function 'sp_cgemv': scipy/sparse/linalg/dsolve/SuperLU/SRC/csp_blas2.c:502:27: warning: suggest parentheses around '&&' within '||' [-Wparentheses] c_eq(&alpha, &comp_zero) && gcc: scipy/sparse/linalg/dsolve/SuperLU/SRC/spivotL.c gcc: scipy/sparse/linalg/dsolve/SuperLU/SRC/cgscon.c gcc: scipy/sparse/linalg/dsolve/SuperLU/SRC/spanel_bmod.c gcc: scipy/sparse/linalg/dsolve/SuperLU/SRC/dcolumn_bmod.c scipy/sparse/linalg/dsolve/SuperLU/SRC/dcolumn_bmod.c: In function 'dcolumn_bmod': scipy/sparse/linalg/dsolve/SuperLU/SRC/dcolumn_bmod.c:283:6: warning: suggest parentheses around assignment used as truth value [-Wparentheses] if (mem_error = dLUMemXpand(jcol, nextlu, LUSUP, &nzlumax, Glu)) ^~~~~~~~~ gcc: scipy/sparse/linalg/dsolve/SuperLU/SRC/csnode_dfs.c scipy/sparse/linalg/dsolve/SuperLU/SRC/csnode_dfs.c: In function 'csnode_dfs': scipy/sparse/linalg/dsolve/SuperLU/SRC/csnode_dfs.c:91:12: warning: suggest parentheses around assignment used as truth value [-Wparentheses] if ( mem_error = cLUMemXpand(jcol, nextl, LSUB, &nzlmax, Glu) ) ^~~~~~~~~ scipy/sparse/linalg/dsolve/SuperLU/SRC/csnode_dfs.c:104:11: warning: suggest parentheses around assignment used as truth value [-Wparentheses] if ( mem_error = cLUMemXpand(jcol, nextl, LSUB, &nzlmax, Glu) ) ^~~~~~~~~ gcc: scipy/sparse/linalg/dsolve/SuperLU/SRC/dpivotL.c gcc: scipy/sparse/linalg/dsolve/SuperLU/SRC/ilu_ddrop_row.c scipy/sparse/linalg/dsolve/SuperLU/SRC/ilu_ddrop_row.c:35:12: warning: '_compare_' defined but not used [-Wunused-function] static int _compare_(const void *a, const void *b) ^~~~~~~~~ gcc: scipy/sparse/linalg/dsolve/SuperLU/SRC/zmemory.c scipy/sparse/linalg/dsolve/SuperLU/SRC/zmemory.c: In function 'zLUMemXpand': scipy/sparse/linalg/dsolve/SuperLU/SRC/zmemory.c:453:5: warning: enumeration value 'LLVL' not handled in switch [-Wswitch] switch ( mem_type ) { ^~~~~~ scipy/sparse/linalg/dsolve/SuperLU/SRC/zmemory.c:453:5: warning: enumeration value 'ULVL' not handled in switch [-Wswitch] gcc: scipy/sparse/linalg/dsolve/SuperLU/SRC/dldperm.c gcc: scipy/sparse/linalg/dsolve/SuperLU/SRC/cpanel_bmod.c gcc: scipy/sparse/linalg/dsolve/SuperLU/SRC/ilu_dpanel_dfs.c gcc: scipy/sparse/linalg/dsolve/SuperLU/SRC/zsp_blas3.c gcc: scipy/sparse/linalg/dsolve/SuperLU/SRC/zpanel_dfs.c gcc: scipy/sparse/linalg/dsolve/SuperLU/SRC/cpivotgrowth.c scipy/sparse/linalg/dsolve/SuperLU/SRC/cpivotgrowth.c: In function 'cPivotGrowth': scipy/sparse/linalg/dsolve/SuperLU/SRC/cpivotgrowth.c:73:15: warning: unused variable 'temp_comp' [-Wunused-variable] complex temp_comp; ^~~~~~~~~ gcc: scipy/sparse/linalg/dsolve/SuperLU/SRC/sdiagonal.c gcc: scipy/sparse/linalg/dsolve/SuperLU/SRC/creadtriple.c scipy/sparse/linalg/dsolve/SuperLU/SRC/creadtriple.c: In function 'creadtriple': scipy/sparse/linalg/dsolve/SuperLU/SRC/creadtriple.c:48:5: warning: ignoring return value of 'scanf', declared with attribute warn_unused_result [-Wunused-result] scanf("%d%d", n, nonz); ^~~~~~~~~~~~~~~~~~~~~~ scipy/sparse/linalg/dsolve/SuperLU/SRC/creadtriple.c:64:2: warning: ignoring return value of 'scanf', declared with attribute warn_unused_result [-Wunused-result] scanf("%d%d%f%f\n", &row[nz], &col[nz], &val[nz].r, &val[nz].i); ^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ scipy/sparse/linalg/dsolve/SuperLU/SRC/creadtriple.c: In function 'creadrhs': scipy/sparse/linalg/dsolve/SuperLU/SRC/creadtriple.c:146:7: warning: ignoring return value of 'fscanf', declared with attribute warn_unused_result [-Wunused-result] fscanf(fp, "%f%f\n", &b[i].r, &b[i].i); ^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ gcc: scipy/sparse/linalg/dsolve/SuperLU/SRC/cpanel_dfs.c gcc: scipy/sparse/linalg/dsolve/SuperLU/SRC/slangs.c scipy/sparse/linalg/dsolve/SuperLU/SRC/slangs.c: In function 'slangs': scipy/sparse/linalg/dsolve/SuperLU/SRC/slangs.c:126:12: warning: 'value' may be used uninitialized in this function [-Wmaybe-uninitialized] return (value); ^ gcc: scipy/sparse/linalg/dsolve/SuperLU/SRC/zlacon2.c scipy/sparse/linalg/dsolve/SuperLU/SRC/zlacon2.c: In function 'zlacon2_': scipy/sparse/linalg/dsolve/SuperLU/SRC/zlacon2.c:175:5: warning: implicit declaration of function 'zcopy_'; did you mean 'zlacon2_'? [-Wimplicit-function-declaration] zcopy_(n, x, &c__1, v, &c__1); ^~~~~~ zlacon2_ scipy/sparse/linalg/dsolve/SuperLU/SRC/zlacon2.c:181:1: warning: label 'L90' defined but not used [-Wunused-label] L90: ^~~ gcc: scipy/sparse/linalg/dsolve/SuperLU/SRC/ilu_zdrop_row.c scipy/sparse/linalg/dsolve/SuperLU/SRC/ilu_zdrop_row.c: In function 'ilu_zdrop_row': scipy/sparse/linalg/dsolve/SuperLU/SRC/ilu_zdrop_row.c:196:3: warning: implicit declaration of function 'dcopy_'; did you mean 'zcopy_'? [-Wimplicit-function-declaration] dcopy_(&len, dwork, &i_1, dwork2, &i_1); ^~~~~~ zcopy_ scipy/sparse/linalg/dsolve/SuperLU/SRC/ilu_zdrop_row.c:85:19: warning: unused variable 'zero' [-Wunused-variable] doublecomplex zero = {0.0, 0.0}; ^~~~ At top level: scipy/sparse/linalg/dsolve/SuperLU/SRC/ilu_zdrop_row.c:35:12: warning: '_compare_' defined but not used [-Wunused-function] static int _compare_(const void *a, const void *b) ^~~~~~~~~ gcc: scipy/sparse/linalg/dsolve/SuperLU/SRC/get_perm_c.c gcc: scipy/sparse/linalg/dsolve/SuperLU/SRC/dzsum1.c gcc: scipy/sparse/linalg/dsolve/SuperLU/SRC/cpruneL.c gcc: scipy/sparse/linalg/dsolve/SuperLU/SRC/creadhb.c scipy/sparse/linalg/dsolve/SuperLU/SRC/creadhb.c: In function 'creadhb': scipy/sparse/linalg/dsolve/SuperLU/SRC/creadhb.c:301:29: warning: unused variable 'key' [-Wunused-variable] char buf[100], type[4], key[10]; ^~~ scipy/sparse/linalg/dsolve/SuperLU/SRC/creadhb.c: In function 'cReadValues': scipy/sparse/linalg/dsolve/SuperLU/SRC/creadhb.c:169:2: warning: ignoring return value of 'fgets', declared with attribute warn_unused_result [-Wunused-result] fgets(buf, 100, fp); /* read a line at a time */ ^~~~~~~~~~~~~~~~~~~ scipy/sparse/linalg/dsolve/SuperLU/SRC/creadhb.c: In function 'creadhb': scipy/sparse/linalg/dsolve/SuperLU/SRC/creadhb.c:305:5: warning: ignoring return value of 'fgets', declared with attribute warn_unused_result [-Wunused-result] fgets(buf, 100, fp); ^~~~~~~~~~~~~~~~~~~ scipy/sparse/linalg/dsolve/SuperLU/SRC/creadhb.c:317:2: warning: ignoring return value of 'fscanf', declared with attribute warn_unused_result [-Wunused-result] fscanf(fp, "%14c", buf); buf[14] = 0; ^~~~~~~~~~~~~~~~~~~~~~~ scipy/sparse/linalg/dsolve/SuperLU/SRC/creadhb.c:325:5: warning: ignoring return value of 'fscanf', declared with attribute warn_unused_result [-Wunused-result] fscanf(fp, "%3c", type); ^~~~~~~~~~~~~~~~~~~~~~~ scipy/sparse/linalg/dsolve/SuperLU/SRC/creadhb.c:326:5: warning: ignoring return value of 'fscanf', declared with attribute warn_unused_result [-Wunused-result] fscanf(fp, "%11c", buf); /* pad */ ^~~~~~~~~~~~~~~~~~~~~~~ scipy/sparse/linalg/dsolve/SuperLU/SRC/creadhb.c:332:5: warning: ignoring return value of 'fscanf', declared with attribute warn_unused_result [-Wunused-result] fscanf(fp, "%14c", buf); sscanf(buf, "%d", nrow); ^~~~~~~~~~~~~~~~~~~~~~~ scipy/sparse/linalg/dsolve/SuperLU/SRC/creadhb.c:333:5: warning: ignoring return value of 'fscanf', declared with attribute warn_unused_result [-Wunused-result] fscanf(fp, "%14c", buf); sscanf(buf, "%d", ncol); ^~~~~~~~~~~~~~~~~~~~~~~ scipy/sparse/linalg/dsolve/SuperLU/SRC/creadhb.c:334:5: warning: ignoring return value of 'fscanf', declared with attribute warn_unused_result [-Wunused-result] fscanf(fp, "%14c", buf); sscanf(buf, "%d", nonz); ^~~~~~~~~~~~~~~~~~~~~~~ scipy/sparse/linalg/dsolve/SuperLU/SRC/creadhb.c:335:5: warning: ignoring return value of 'fscanf', declared with attribute warn_unused_result [-Wunused-result] fscanf(fp, "%14c", buf); sscanf(buf, "%d", &tmp); ^~~~~~~~~~~~~~~~~~~~~~~ scipy/sparse/linalg/dsolve/SuperLU/SRC/creadhb.c:347:5: warning: ignoring return value of 'fscanf', declared with attribute warn_unused_result [-Wunused-result] fscanf(fp, "%16c", buf); ^~~~~~~~~~~~~~~~~~~~~~~ scipy/sparse/linalg/dsolve/SuperLU/SRC/creadhb.c:349:5: warning: ignoring return value of 'fscanf', declared with attribute warn_unused_result [-Wunused-result] fscanf(fp, "%16c", buf); ^~~~~~~~~~~~~~~~~~~~~~~ scipy/sparse/linalg/dsolve/SuperLU/SRC/creadhb.c:351:5: warning: ignoring return value of 'fscanf', declared with attribute warn_unused_result [-Wunused-result] fscanf(fp, "%20c", buf); ^~~~~~~~~~~~~~~~~~~~~~~ scipy/sparse/linalg/dsolve/SuperLU/SRC/creadhb.c:353:5: warning: ignoring return value of 'fscanf', declared with attribute warn_unused_result [-Wunused-result] fscanf(fp, "%20c", buf); ^~~~~~~~~~~~~~~~~~~~~~~ scipy/sparse/linalg/dsolve/SuperLU/SRC/creadhb.c: In function 'ReadVector': scipy/sparse/linalg/dsolve/SuperLU/SRC/creadhb.c:147:2: warning: ignoring return value of 'fgets', declared with attribute warn_unused_result [-Wunused-result] fgets(buf, 100, fp); /* read a line at a time */ ^~~~~~~~~~~~~~~~~~~ gcc: scipy/sparse/linalg/dsolve/SuperLU/SRC/ilu_csnode_dfs.c gcc: scipy/sparse/linalg/dsolve/SuperLU/SRC/ccopy_to_ucol.c scipy/sparse/linalg/dsolve/SuperLU/SRC/ccopy_to_ucol.c: In function 'ccopy_to_ucol': scipy/sparse/linalg/dsolve/SuperLU/SRC/ccopy_to_ucol.c:87:11: warning: suggest parentheses around assignment used as truth value [-Wparentheses] if (mem_error = cLUMemXpand(jcol, nextu, UCOL, &nzumax, Glu)) ^~~~~~~~~ scipy/sparse/linalg/dsolve/SuperLU/SRC/ccopy_to_ucol.c:90:11: warning: suggest parentheses around assignment used as truth value [-Wparentheses] if (mem_error = cLUMemXpand(jcol, nextu, USUB, &nzumax, Glu)) ^~~~~~~~~ gcc: scipy/sparse/linalg/dsolve/SuperLU/SRC/zreadhb.c scipy/sparse/linalg/dsolve/SuperLU/SRC/zreadhb.c: In function 'zreadhb': scipy/sparse/linalg/dsolve/SuperLU/SRC/zreadhb.c:301:29: warning: unused variable 'key' [-Wunused-variable] char buf[100], type[4], key[10]; ^~~ scipy/sparse/linalg/dsolve/SuperLU/SRC/zreadhb.c: In function 'zReadValues': scipy/sparse/linalg/dsolve/SuperLU/SRC/zreadhb.c:169:2: warning: ignoring return value of 'fgets', declared with attribute warn_unused_result [-Wunused-result] fgets(buf, 100, fp); /* read a line at a time */ ^~~~~~~~~~~~~~~~~~~ scipy/sparse/linalg/dsolve/SuperLU/SRC/zreadhb.c: In function 'zreadhb': scipy/sparse/linalg/dsolve/SuperLU/SRC/zreadhb.c:305:5: warning: ignoring return value of 'fgets', declared with attribute warn_unused_result [-Wunused-result] fgets(buf, 100, fp); ^~~~~~~~~~~~~~~~~~~ scipy/sparse/linalg/dsolve/SuperLU/SRC/zreadhb.c:317:2: warning: ignoring return value of 'fscanf', declared with attribute warn_unused_result [-Wunused-result] fscanf(fp, "%14c", buf); buf[14] = 0; ^~~~~~~~~~~~~~~~~~~~~~~ scipy/sparse/linalg/dsolve/SuperLU/SRC/zreadhb.c:325:5: warning: ignoring return value of 'fscanf', declared with attribute warn_unused_result [-Wunused-result] fscanf(fp, "%3c", type); ^~~~~~~~~~~~~~~~~~~~~~~ scipy/sparse/linalg/dsolve/SuperLU/SRC/zreadhb.c:326:5: warning: ignoring return value of 'fscanf', declared with attribute warn_unused_result [-Wunused-result] fscanf(fp, "%11c", buf); /* pad */ ^~~~~~~~~~~~~~~~~~~~~~~ scipy/sparse/linalg/dsolve/SuperLU/SRC/zreadhb.c:332:5: warning: ignoring return value of 'fscanf', declared with attribute warn_unused_result [-Wunused-result] fscanf(fp, "%14c", buf); sscanf(buf, "%d", nrow); ^~~~~~~~~~~~~~~~~~~~~~~ scipy/sparse/linalg/dsolve/SuperLU/SRC/zreadhb.c:333:5: warning: ignoring return value of 'fscanf', declared with attribute warn_unused_result [-Wunused-result] fscanf(fp, "%14c", buf); sscanf(buf, "%d", ncol); ^~~~~~~~~~~~~~~~~~~~~~~ scipy/sparse/linalg/dsolve/SuperLU/SRC/zreadhb.c:334:5: warning: ignoring return value of 'fscanf', declared with attribute warn_unused_result [-Wunused-result] fscanf(fp, "%14c", buf); sscanf(buf, "%d", nonz); ^~~~~~~~~~~~~~~~~~~~~~~ scipy/sparse/linalg/dsolve/SuperLU/SRC/zreadhb.c:335:5: warning: ignoring return value of 'fscanf', declared with attribute warn_unused_result [-Wunused-result] fscanf(fp, "%14c", buf); sscanf(buf, "%d", &tmp); ^~~~~~~~~~~~~~~~~~~~~~~ scipy/sparse/linalg/dsolve/SuperLU/SRC/zreadhb.c:347:5: warning: ignoring return value of 'fscanf', declared with attribute warn_unused_result [-Wunused-result] fscanf(fp, "%16c", buf); ^~~~~~~~~~~~~~~~~~~~~~~ scipy/sparse/linalg/dsolve/SuperLU/SRC/zreadhb.c:349:5: warning: ignoring return value of 'fscanf', declared with attribute warn_unused_result [-Wunused-result] fscanf(fp, "%16c", buf); ^~~~~~~~~~~~~~~~~~~~~~~ scipy/sparse/linalg/dsolve/SuperLU/SRC/zreadhb.c:351:5: warning: ignoring return value of 'fscanf', declared with attribute warn_unused_result [-Wunused-result] fscanf(fp, "%20c", buf); ^~~~~~~~~~~~~~~~~~~~~~~ scipy/sparse/linalg/dsolve/SuperLU/SRC/zreadhb.c:353:5: warning: ignoring return value of 'fscanf', declared with attribute warn_unused_result [-Wunused-result] fscanf(fp, "%20c", buf); ^~~~~~~~~~~~~~~~~~~~~~~ scipy/sparse/linalg/dsolve/SuperLU/SRC/zreadhb.c: In function 'ReadVector': scipy/sparse/linalg/dsolve/SuperLU/SRC/zreadhb.c:147:2: warning: ignoring return value of 'fgets', declared with attribute warn_unused_result [-Wunused-result] fgets(buf, 100, fp); /* read a line at a time */ ^~~~~~~~~~~~~~~~~~~ gcc: scipy/sparse/linalg/dsolve/SuperLU/SRC/zcolumn_dfs.c scipy/sparse/linalg/dsolve/SuperLU/SRC/zcolumn_dfs.c: In function 'zcolumn_dfs': scipy/sparse/linalg/dsolve/SuperLU/SRC/zcolumn_dfs.c:139:8: warning: suggest parentheses around assignment used as truth value [-Wparentheses] if ( mem_error = zLUMemXpand(jcol, nextl, LSUB, &nzlmax, Glu) ) ^~~~~~~~~ scipy/sparse/linalg/dsolve/SuperLU/SRC/zcolumn_dfs.c:181:14: warning: suggest parentheses around assignment used as truth value [-Wparentheses] if ( mem_error = ^~~~~~~~~ gcc: scipy/sparse/linalg/dsolve/SuperLU/SRC/dlacon2.c gcc: scipy/sparse/linalg/dsolve/SuperLU/SRC/ilu_zsnode_dfs.c gcc: scipy/sparse/linalg/dsolve/SuperLU/SRC/sgstrf.c gcc: scipy/sparse/linalg/dsolve/SuperLU/SRC/dgsrfs.c gcc: scipy/sparse/linalg/dsolve/SuperLU/SRC/zgssvx.c scipy/sparse/linalg/dsolve/SuperLU/SRC/zgssvx.c: In function 'zgssvx': scipy/sparse/linalg/dsolve/SuperLU/SRC/zgssvx.c:377:15: warning: variable 'diag_pivot_thresh' set but not used [-Wunused-but-set-variable] double diag_pivot_thresh; ^~~~~~~~~~~~~~~~~ In file included from scipy/sparse/linalg/dsolve/SuperLU/SRC/slu_zdefs.h:101, from scipy/sparse/linalg/dsolve/SuperLU/SRC/zgssvx.c:22: scipy/sparse/linalg/dsolve/SuperLU/SRC/slu_util.h:95:46: warning: 'smlnum' may be used uninitialized in this function [-Wmaybe-uninitialized] #define SUPERLU_MAX(x, y) ( (x) > (y) ? (x) : (y) ) ^ scipy/sparse/linalg/dsolve/SuperLU/SRC/zgssvx.c:375:36: note: 'smlnum' was declared here double amax, anorm, bignum, smlnum, colcnd, rowcnd, rcmax, rcmin; ^~~~~~ In file included from scipy/sparse/linalg/dsolve/SuperLU/SRC/slu_zdefs.h:101, from scipy/sparse/linalg/dsolve/SuperLU/SRC/zgssvx.c:22: scipy/sparse/linalg/dsolve/SuperLU/SRC/slu_util.h:96:46: warning: 'bignum' may be used uninitialized in this function [-Wmaybe-uninitialized] #define SUPERLU_MIN(x, y) ( (x) < (y) ? (x) : (y) ) ^ scipy/sparse/linalg/dsolve/SuperLU/SRC/zgssvx.c:375:28: note: 'bignum' was declared here double amax, anorm, bignum, smlnum, colcnd, rowcnd, rcmax, rcmin; ^~~~~~ gcc: scipy/sparse/linalg/dsolve/SuperLU/SRC/ilu_zpanel_dfs.c gcc: scipy/sparse/linalg/dsolve/SuperLU/SRC/dpanel_bmod.c gcc: scipy/sparse/linalg/dsolve/SuperLU/SRC/spanel_dfs.c gcc: scipy/sparse/linalg/dsolve/SuperLU/SRC/mark_relax.c gcc: scipy/sparse/linalg/dsolve/SuperLU/SRC/zreadtriple.c scipy/sparse/linalg/dsolve/SuperLU/SRC/zreadtriple.c: In function 'zreadtriple': scipy/sparse/linalg/dsolve/SuperLU/SRC/zreadtriple.c:48:5: warning: ignoring return value of 'scanf', declared with attribute warn_unused_result [-Wunused-result] scanf("%d%d", n, nonz); ^~~~~~~~~~~~~~~~~~~~~~ scipy/sparse/linalg/dsolve/SuperLU/SRC/zreadtriple.c:64:2: warning: ignoring return value of 'scanf', declared with attribute warn_unused_result [-Wunused-result] scanf("%d%d%lf%lf\n", &row[nz], &col[nz], &val[nz].r, &val[nz].i); ^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ scipy/sparse/linalg/dsolve/SuperLU/SRC/zreadtriple.c: In function 'zreadrhs': scipy/sparse/linalg/dsolve/SuperLU/SRC/zreadtriple.c:146:7: warning: ignoring return value of 'fscanf', declared with attribute warn_unused_result [-Wunused-result] fscanf(fp, "%lf%lf\n", &b[i].r, &b[i].i); ^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ gcc: scipy/sparse/linalg/dsolve/SuperLU/SRC/heap_relax_snode.c gcc: scipy/sparse/linalg/dsolve/SuperLU/SRC/ssp_blas2.c gcc: scipy/sparse/linalg/dsolve/SuperLU/SRC/cgssv.c scipy/sparse/linalg/dsolve/SuperLU/SRC/cgssv.c: In function 'cgssv': scipy/sparse/linalg/dsolve/SuperLU/SRC/cgssv.c:210:5: warning: 'AA' may be used uninitialized in this function [-Wmaybe-uninitialized] sp_preorder(options, AA, perm_c, etree, &AC); ^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ gcc: scipy/sparse/linalg/dsolve/SuperLU/SRC/zpivotgrowth.c scipy/sparse/linalg/dsolve/SuperLU/SRC/zpivotgrowth.c: In function 'zPivotGrowth': scipy/sparse/linalg/dsolve/SuperLU/SRC/zpivotgrowth.c:73:21: warning: unused variable 'temp_comp' [-Wunused-variable] doublecomplex temp_comp; ^~~~~~~~~ gcc: scipy/sparse/linalg/dsolve/SuperLU/SRC/ilu_scopy_to_ucol.c gcc: scipy/sparse/linalg/dsolve/SuperLU/SRC/ilu_zcopy_to_ucol.c scipy/sparse/linalg/dsolve/SuperLU/SRC/ilu_zcopy_to_ucol.c: In function 'ilu_zcopy_to_ucol': scipy/sparse/linalg/dsolve/SuperLU/SRC/ilu_zcopy_to_ucol.c:193:11: warning: 'tmp' may be used uninitialized in this function [-Wmaybe-uninitialized] sum->r += tmp; ^~ gcc: scipy/sparse/linalg/dsolve/SuperLU/SRC/spivotgrowth.c gcc: scipy/sparse/linalg/dsolve/SuperLU/SRC/csp_blas3.c gcc: scipy/sparse/linalg/dsolve/SuperLU/SRC/dgssv.c scipy/sparse/linalg/dsolve/SuperLU/SRC/dgssv.c: In function 'dgssv': scipy/sparse/linalg/dsolve/SuperLU/SRC/dgssv.c:210:5: warning: 'AA' may be used uninitialized in this function [-Wmaybe-uninitialized] sp_preorder(options, AA, perm_c, etree, &AC); ^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ gcc: scipy/sparse/linalg/dsolve/SuperLU/SRC/dgssvx.c scipy/sparse/linalg/dsolve/SuperLU/SRC/dgssvx.c: In function 'dgssvx': scipy/sparse/linalg/dsolve/SuperLU/SRC/dgssvx.c:377:15: warning: variable 'diag_pivot_thresh' set but not used [-Wunused-but-set-variable] double diag_pivot_thresh; ^~~~~~~~~~~~~~~~~ In file included from scipy/sparse/linalg/dsolve/SuperLU/SRC/slu_ddefs.h:101, from scipy/sparse/linalg/dsolve/SuperLU/SRC/dgssvx.c:22: scipy/sparse/linalg/dsolve/SuperLU/SRC/slu_util.h:95:46: warning: 'smlnum' may be used uninitialized in this function [-Wmaybe-uninitialized] #define SUPERLU_MAX(x, y) ( (x) > (y) ? (x) : (y) ) ^ scipy/sparse/linalg/dsolve/SuperLU/SRC/dgssvx.c:375:36: note: 'smlnum' was declared here double amax, anorm, bignum, smlnum, colcnd, rowcnd, rcmax, rcmin; ^~~~~~ In file included from scipy/sparse/linalg/dsolve/SuperLU/SRC/slu_ddefs.h:101, from scipy/sparse/linalg/dsolve/SuperLU/SRC/dgssvx.c:22: scipy/sparse/linalg/dsolve/SuperLU/SRC/slu_util.h:96:46: warning: 'bignum' may be used uninitialized in this function [-Wmaybe-uninitialized] #define SUPERLU_MIN(x, y) ( (x) < (y) ? (x) : (y) ) ^ scipy/sparse/linalg/dsolve/SuperLU/SRC/dgssvx.c:375:28: note: 'bignum' was declared here double amax, anorm, bignum, smlnum, colcnd, rowcnd, rcmax, rcmin; ^~~~~~ gcc: scipy/sparse/linalg/dsolve/SuperLU/SRC/scolumn_bmod.c scipy/sparse/linalg/dsolve/SuperLU/SRC/scolumn_bmod.c: In function 'scolumn_bmod': scipy/sparse/linalg/dsolve/SuperLU/SRC/scolumn_bmod.c:283:6: warning: suggest parentheses around assignment used as truth value [-Wparentheses] if (mem_error = sLUMemXpand(jcol, nextlu, LUSUP, &nzlumax, Glu)) ^~~~~~~~~ gcc: scipy/sparse/linalg/dsolve/SuperLU/SRC/smach.c scipy/sparse/linalg/dsolve/SuperLU/SRC/smach.c: In function 'smach': scipy/sparse/linalg/dsolve/SuperLU/SRC/smach.c:62:9: warning: implicit declaration of function 'strncmp' [-Wimplicit-function-declaration] if (strncmp(cmach, "E", 1)==0) { ^~~~~~~ scipy/sparse/linalg/dsolve/SuperLU/SRC/smach.c:91:12: warning: 'rmach' may be used uninitialized in this function [-Wmaybe-uninitialized] return rmach; ^~~~~ gcc: scipy/sparse/linalg/dsolve/SuperLU/SRC/ilu_ccolumn_dfs.c gcc: scipy/sparse/linalg/dsolve/SuperLU/SRC/ilu_sdrop_row.c scipy/sparse/linalg/dsolve/SuperLU/SRC/ilu_sdrop_row.c:35:12: warning: '_compare_' defined but not used [-Wunused-function] static int _compare_(const void *a, const void *b) ^~~~~~~~~ gcc: scipy/sparse/linalg/dsolve/SuperLU/SRC/cgstrs.c scipy/sparse/linalg/dsolve/SuperLU/SRC/cgstrs.c: In function 'cgstrs': scipy/sparse/linalg/dsolve/SuperLU/SRC/cgstrs.c:108:24: warning: unused variable 'incy' [-Wunused-variable] int incx = 1, incy = 1; ^~~~ scipy/sparse/linalg/dsolve/SuperLU/SRC/cgstrs.c:108:14: warning: unused variable 'incx' [-Wunused-variable] int incx = 1, incy = 1; ^~~~ gcc: scipy/sparse/linalg/dsolve/SuperLU/SRC/sp_coletree.c scipy/sparse/linalg/dsolve/SuperLU/SRC/sp_coletree.c:253:6: warning: 'etdfs' defined but not used [-Wunused-function] void etdfs ( ^~~~~ gcc: scipy/sparse/linalg/dsolve/SuperLU/SRC/sutil.c scipy/sparse/linalg/dsolve/SuperLU/SRC/sutil.c: In function 'sFillRHS': scipy/sparse/linalg/dsolve/SuperLU/SRC/sutil.c:368:14: warning: variable 'Aval' set but not used [-Wunused-but-set-variable] float *Aval; ^~~~ scipy/sparse/linalg/dsolve/SuperLU/SRC/sutil.c: At top level: scipy/sparse/linalg/dsolve/SuperLU/SRC/sutil.c:474:1: warning: return type defaults to 'int' [-Wimplicit-int] print_float_vec(char *what, int n, float *vec) ^~~~~~~~~~~~~~~ gcc: scipy/sparse/linalg/dsolve/SuperLU/SRC/zsp_blas2.c scipy/sparse/linalg/dsolve/SuperLU/SRC/zsp_blas2.c: In function 'sp_zgemv': scipy/sparse/linalg/dsolve/SuperLU/SRC/zsp_blas2.c:502:27: warning: suggest parentheses around '&&' within '||' [-Wparentheses] z_eq(&alpha, &comp_zero) && gcc: scipy/sparse/linalg/dsolve/SuperLU/SRC/dreadrb.c scipy/sparse/linalg/dsolve/SuperLU/SRC/dreadrb.c: In function 'dreadrb': scipy/sparse/linalg/dsolve/SuperLU/SRC/dreadrb.c:295:5: warning: ignoring return value of 'fgets', declared with attribute warn_unused_result [-Wunused-result] fgets(buf, 100, fp); ^~~~~~~~~~~~~~~~~~~ scipy/sparse/linalg/dsolve/SuperLU/SRC/dreadrb.c:300:9: warning: ignoring return value of 'fscanf', declared with attribute warn_unused_result [-Wunused-result] fscanf(fp, "%14c", buf); buf[14] = 0; ^~~~~~~~~~~~~~~~~~~~~~~ scipy/sparse/linalg/dsolve/SuperLU/SRC/dreadrb.c:307:5: warning: ignoring return value of 'fscanf', declared with attribute warn_unused_result [-Wunused-result] fscanf(fp, "%3c", type); ^~~~~~~~~~~~~~~~~~~~~~~ scipy/sparse/linalg/dsolve/SuperLU/SRC/dreadrb.c:308:5: warning: ignoring return value of 'fscanf', declared with attribute warn_unused_result [-Wunused-result] fscanf(fp, "%11c", buf); /* pad */ ^~~~~~~~~~~~~~~~~~~~~~~ scipy/sparse/linalg/dsolve/SuperLU/SRC/dreadrb.c:314:5: warning: ignoring return value of 'fscanf', declared with attribute warn_unused_result [-Wunused-result] fscanf(fp, "%14c", buf); sscanf(buf, "%d", nrow); ^~~~~~~~~~~~~~~~~~~~~~~ scipy/sparse/linalg/dsolve/SuperLU/SRC/dreadrb.c:315:5: warning: ignoring return value of 'fscanf', declared with attribute warn_unused_result [-Wunused-result] fscanf(fp, "%14c", buf); sscanf(buf, "%d", ncol); ^~~~~~~~~~~~~~~~~~~~~~~ scipy/sparse/linalg/dsolve/SuperLU/SRC/dreadrb.c:316:5: warning: ignoring return value of 'fscanf', declared with attribute warn_unused_result [-Wunused-result] fscanf(fp, "%14c", buf); sscanf(buf, "%d", nonz); ^~~~~~~~~~~~~~~~~~~~~~~ scipy/sparse/linalg/dsolve/SuperLU/SRC/dreadrb.c:317:5: warning: ignoring return value of 'fscanf', declared with attribute warn_unused_result [-Wunused-result] fscanf(fp, "%14c", buf); sscanf(buf, "%d", &tmp); ^~~~~~~~~~~~~~~~~~~~~~~ scipy/sparse/linalg/dsolve/SuperLU/SRC/dreadrb.c:329:5: warning: ignoring return value of 'fscanf', declared with attribute warn_unused_result [-Wunused-result] fscanf(fp, "%16c", buf); ^~~~~~~~~~~~~~~~~~~~~~~ scipy/sparse/linalg/dsolve/SuperLU/SRC/dreadrb.c:331:5: warning: ignoring return value of 'fscanf', declared with attribute warn_unused_result [-Wunused-result] fscanf(fp, "%16c", buf); ^~~~~~~~~~~~~~~~~~~~~~~ scipy/sparse/linalg/dsolve/SuperLU/SRC/dreadrb.c:333:5: warning: ignoring return value of 'fscanf', declared with attribute warn_unused_result [-Wunused-result] fscanf(fp, "%20c", buf); ^~~~~~~~~~~~~~~~~~~~~~~ scipy/sparse/linalg/dsolve/SuperLU/SRC/dreadrb.c: In function 'ReadVector': scipy/sparse/linalg/dsolve/SuperLU/SRC/dreadrb.c:142:9: warning: ignoring return value of 'fgets', declared with attribute warn_unused_result [-Wunused-result] fgets(buf, 100, fp); /* read a line at a time */ ^~~~~~~~~~~~~~~~~~~ scipy/sparse/linalg/dsolve/SuperLU/SRC/dreadrb.c: In function 'dReadValues': scipy/sparse/linalg/dsolve/SuperLU/SRC/dreadrb.c:163:9: warning: ignoring return value of 'fgets', declared with attribute warn_unused_result [-Wunused-result] fgets(buf, 100, fp); /* read a line at a time */ ^~~~~~~~~~~~~~~~~~~ gcc: scipy/sparse/linalg/dsolve/SuperLU/SRC/ilu_cdrop_row.c scipy/sparse/linalg/dsolve/SuperLU/SRC/ilu_cdrop_row.c: In function 'ilu_cdrop_row': scipy/sparse/linalg/dsolve/SuperLU/SRC/ilu_cdrop_row.c:196:3: warning: implicit declaration of function 'scopy_'; did you mean 'ccopy_'? [-Wimplicit-function-declaration] scopy_(&len, swork, &i_1, swork2, &i_1); ^~~~~~ ccopy_ scipy/sparse/linalg/dsolve/SuperLU/SRC/ilu_cdrop_row.c:85:13: warning: unused variable 'zero' [-Wunused-variable] complex zero = {0.0, 0.0}; ^~~~ At top level: scipy/sparse/linalg/dsolve/SuperLU/SRC/ilu_cdrop_row.c:35:12: warning: '_compare_' defined but not used [-Wunused-function] static int _compare_(const void *a, const void *b) ^~~~~~~~~ gcc: scipy/sparse/linalg/dsolve/SuperLU/SRC/zlaqgs.c gcc: scipy/sparse/linalg/dsolve/SuperLU/SRC/clacon2.c scipy/sparse/linalg/dsolve/SuperLU/SRC/clacon2.c: In function 'clacon2_': scipy/sparse/linalg/dsolve/SuperLU/SRC/clacon2.c:175:5: warning: implicit declaration of function 'ccopy_'; did you mean 'clacon2_'? [-Wimplicit-function-declaration] ccopy_(n, x, &c__1, v, &c__1); ^~~~~~ clacon2_ scipy/sparse/linalg/dsolve/SuperLU/SRC/clacon2.c:181:1: warning: label 'L90' defined but not used [-Wunused-label] L90: ^~~ gcc: scipy/sparse/linalg/dsolve/SuperLU/SRC/cmyblas2.c gcc: scipy/sparse/linalg/dsolve/SuperLU/SRC/ilu_ccopy_to_ucol.c scipy/sparse/linalg/dsolve/SuperLU/SRC/ilu_ccopy_to_ucol.c: In function 'ilu_ccopy_to_ucol': scipy/sparse/linalg/dsolve/SuperLU/SRC/ilu_ccopy_to_ucol.c:193:11: warning: 'tmp' may be used uninitialized in this function [-Wmaybe-uninitialized] sum->r += tmp; ^~ gcc: scipy/sparse/linalg/dsolve/SuperLU/SRC/scopy_to_ucol.c scipy/sparse/linalg/dsolve/SuperLU/SRC/scopy_to_ucol.c: In function 'scopy_to_ucol': scipy/sparse/linalg/dsolve/SuperLU/SRC/scopy_to_ucol.c:87:11: warning: suggest parentheses around assignment used as truth value [-Wparentheses] if (mem_error = sLUMemXpand(jcol, nextu, UCOL, &nzumax, Glu)) ^~~~~~~~~ scipy/sparse/linalg/dsolve/SuperLU/SRC/scopy_to_ucol.c:90:11: warning: suggest parentheses around assignment used as truth value [-Wparentheses] if (mem_error = sLUMemXpand(jcol, nextu, USUB, &nzumax, Glu)) ^~~~~~~~~ gcc: scipy/sparse/linalg/dsolve/SuperLU/SRC/dsp_blas2.c gcc: scipy/sparse/linalg/dsolve/SuperLU/SRC/ccolumn_bmod.c scipy/sparse/linalg/dsolve/SuperLU/SRC/ccolumn_bmod.c: In function 'ccolumn_bmod': scipy/sparse/linalg/dsolve/SuperLU/SRC/ccolumn_bmod.c:296:6: warning: suggest parentheses around assignment used as truth value [-Wparentheses] if (mem_error = cLUMemXpand(jcol, nextlu, LUSUP, &nzlumax, Glu)) ^~~~~~~~~ gcc: scipy/sparse/linalg/dsolve/SuperLU/SRC/ssnode_dfs.c scipy/sparse/linalg/dsolve/SuperLU/SRC/ssnode_dfs.c: In function 'ssnode_dfs': scipy/sparse/linalg/dsolve/SuperLU/SRC/ssnode_dfs.c:91:12: warning: suggest parentheses around assignment used as truth value [-Wparentheses] if ( mem_error = sLUMemXpand(jcol, nextl, LSUB, &nzlmax, Glu) ) ^~~~~~~~~ scipy/sparse/linalg/dsolve/SuperLU/SRC/ssnode_dfs.c:104:11: warning: suggest parentheses around assignment used as truth value [-Wparentheses] if ( mem_error = sLUMemXpand(jcol, nextl, LSUB, &nzlmax, Glu) ) ^~~~~~~~~ gcc: scipy/sparse/linalg/dsolve/SuperLU/SRC/cgsisx.c scipy/sparse/linalg/dsolve/SuperLU/SRC/cgsisx.c: In function 'cgsisx': scipy/sparse/linalg/dsolve/SuperLU/SRC/cgsisx.c:588:7: warning: suggest parentheses around operand of '!' or change '&' to '&&' or '!' to '~' [-Wparentheses] if ( !mc64 & equil ) { /* Only perform equilibration, no row perm */ ^~~~~ scipy/sparse/linalg/dsolve/SuperLU/SRC/cgsisx.c:677:18: warning: unused variable 'rhs_work' [-Wunused-variable] complex *rhs_work; ^~~~~~~~ scipy/sparse/linalg/dsolve/SuperLU/SRC/cgsisx.c:423:14: warning: variable 'diag_pivot_thresh' set but not used [-Wunused-but-set-variable] float diag_pivot_thresh; ^~~~~~~~~~~~~~~~~ In file included from scipy/sparse/linalg/dsolve/SuperLU/SRC/slu_cdefs.h:101, from scipy/sparse/linalg/dsolve/SuperLU/SRC/cgsisx.c:22: scipy/sparse/linalg/dsolve/SuperLU/SRC/slu_util.h:95:46: warning: 'smlnum' may be used uninitialized in this function [-Wmaybe-uninitialized] #define SUPERLU_MAX(x, y) ( (x) > (y) ? (x) : (y) ) ^ scipy/sparse/linalg/dsolve/SuperLU/SRC/cgsisx.c:421:35: note: 'smlnum' was declared here float amax, anorm, bignum, smlnum, colcnd, rowcnd, rcmax, rcmin; ^~~~~~ In file included from scipy/sparse/linalg/dsolve/SuperLU/SRC/slu_cdefs.h:101, from scipy/sparse/linalg/dsolve/SuperLU/SRC/cgsisx.c:22: scipy/sparse/linalg/dsolve/SuperLU/SRC/slu_util.h:96:46: warning: 'bignum' may be used uninitialized in this function [-Wmaybe-uninitialized] #define SUPERLU_MIN(x, y) ( (x) < (y) ? (x) : (y) ) ^ scipy/sparse/linalg/dsolve/SuperLU/SRC/cgsisx.c:421:27: note: 'bignum' was declared here float amax, anorm, bignum, smlnum, colcnd, rowcnd, rcmax, rcmin; ^~~~~~ gcc: scipy/sparse/linalg/dsolve/SuperLU/SRC/dcolumn_dfs.c scipy/sparse/linalg/dsolve/SuperLU/SRC/dcolumn_dfs.c: In function 'dcolumn_dfs': scipy/sparse/linalg/dsolve/SuperLU/SRC/dcolumn_dfs.c:139:8: warning: suggest parentheses around assignment used as truth value [-Wparentheses] if ( mem_error = dLUMemXpand(jcol, nextl, LSUB, &nzlmax, Glu) ) ^~~~~~~~~ scipy/sparse/linalg/dsolve/SuperLU/SRC/dcolumn_dfs.c:181:14: warning: suggest parentheses around assignment used as truth value [-Wparentheses] if ( mem_error = ^~~~~~~~~ gcc: scipy/sparse/linalg/dsolve/SuperLU/SRC/sgstrs.c scipy/sparse/linalg/dsolve/SuperLU/SRC/sgstrs.c: In function 'sgstrs': scipy/sparse/linalg/dsolve/SuperLU/SRC/sgstrs.c:108:24: warning: unused variable 'incy' [-Wunused-variable] int incx = 1, incy = 1; ^~~~ scipy/sparse/linalg/dsolve/SuperLU/SRC/sgstrs.c:108:14: warning: unused variable 'incx' [-Wunused-variable] int incx = 1, incy = 1; ^~~~ gcc: scipy/sparse/linalg/dsolve/SuperLU/SRC/sldperm.c gcc: scipy/sparse/linalg/dsolve/SuperLU/SRC/dgstrs.c scipy/sparse/linalg/dsolve/SuperLU/SRC/dgstrs.c: In function 'dgstrs': scipy/sparse/linalg/dsolve/SuperLU/SRC/dgstrs.c:108:24: warning: unused variable 'incy' [-Wunused-variable] int incx = 1, incy = 1; ^~~~ scipy/sparse/linalg/dsolve/SuperLU/SRC/dgstrs.c:108:14: warning: unused variable 'incx' [-Wunused-variable] int incx = 1, incy = 1; ^~~~ gcc: scipy/sparse/linalg/dsolve/SuperLU/SRC/ilu_cpanel_dfs.c gcc: scipy/sparse/linalg/dsolve/SuperLU/SRC/dgsequ.c gcc: scipy/sparse/linalg/dsolve/SuperLU/SRC/zldperm.c gcc: scipy/sparse/linalg/dsolve/SuperLU/SRC/mmd.c gcc: scipy/sparse/linalg/dsolve/SuperLU/SRC/dsp_blas3.c gcc: scipy/sparse/linalg/dsolve/SuperLU/SRC/dmyblas2.c ar: adding 50 object files to build/temp.linux-ppc64le-2.7/libsuperlu_src.a ar: adding 50 object files to build/temp.linux-ppc64le-2.7/libsuperlu_src.a ar: adding 50 object files to build/temp.linux-ppc64le-2.7/libsuperlu_src.a ar: adding 25 object files to build/temp.linux-ppc64le-2.7/libsuperlu_src.a building 'arpack_scipy' library compiling Fortran sources Fortran f77 compiler: /usr/bin/gfortran -Wall -g -ffixed-form -fno-second-underscore -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -fPIC -cpp -O3 -funroll-loops Fortran f90 compiler: /usr/bin/gfortran -Wall -g -fno-second-underscore -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -fPIC -cpp -O3 -funroll-loops Fortran fix compiler: /usr/bin/gfortran -Wall -g -ffixed-form -fno-second-underscore -Wall -g -fno-second-underscore -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -fPIC -cpp -O3 -funroll-loops creating build/temp.linux-ppc64le-2.7/scipy/sparse/linalg/eigen creating build/temp.linux-ppc64le-2.7/scipy/sparse/linalg/eigen/arpack creating build/temp.linux-ppc64le-2.7/scipy/sparse/linalg/eigen/arpack/ARPACK creating build/temp.linux-ppc64le-2.7/scipy/sparse/linalg/eigen/arpack/ARPACK/SRC creating build/temp.linux-ppc64le-2.7/scipy/sparse/linalg/eigen/arpack/ARPACK/UTIL compile options: '-Iscipy/sparse/linalg/eigen/arpack/ARPACK/SRC -I/usr/lib64/python2.7/site-packages/numpy/core/include -c' gfortran:f77: scipy/sparse/linalg/eigen/arpack/ARPACK/SRC/cnaup2.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran scipy/sparse/linalg/eigen/arpack/ARPACK/SRC/cnaup2.f:322:5: 10 continue 1 Warning: Label 10 at (1) defined but not used [-Wunused-label] scipy/sparse/linalg/eigen/arpack/ARPACK/SRC/cnaup2.f:169:63: & ( ido, bmat, n, which, nev, np, tol, resid, mode, iupd, 1 Warning: Unused dummy argument 'iupd' at (1) [-Wunused-dummy-argument] stat.h:8:35: Warning: Unused variable 't4' declared at (1) [-Wunused-variable] stat.h:8:39: Warning: Unused variable 't5' declared at (1) [-Wunused-variable] gfortran:f77: scipy/sparse/linalg/eigen/arpack/ARPACK/SRC/dsgets.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran stat.h:8:27: Warning: Unused variable 't2' declared at (1) [-Wunused-variable] stat.h:8:31: Warning: Unused variable 't3' declared at (1) [-Wunused-variable] stat.h:8:35: Warning: Unused variable 't4' declared at (1) [-Wunused-variable] stat.h:8:39: Warning: Unused variable 't5' declared at (1) [-Wunused-variable] gfortran:f77: scipy/sparse/linalg/eigen/arpack/ARPACK/SRC/cneupd.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran scipy/sparse/linalg/eigen/arpack/ARPACK/SRC/cneupd.f:520:17: jj = workl(bounds + ncv - j) 1 Warning: Possible change of value in conversion from COMPLEX(4) to INTEGER(4) at (1) [-Wconversion] stat.h:8:19: Warning: Unused variable 't0' declared at (1) [-Wunused-variable] stat.h:8:23: Warning: Unused variable 't1' declared at (1) [-Wunused-variable] stat.h:8:27: Warning: Unused variable 't2' declared at (1) [-Wunused-variable] stat.h:8:31: Warning: Unused variable 't3' declared at (1) [-Wunused-variable] stat.h:8:35: Warning: Unused variable 't4' declared at (1) [-Wunused-variable] stat.h:8:39: Warning: Unused variable 't5' declared at (1) [-Wunused-variable] gfortran:f77: scipy/sparse/linalg/eigen/arpack/ARPACK/SRC/dnapps.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran stat.h:8:27: Warning: Unused variable 't2' declared at (1) [-Wunused-variable] stat.h:8:31: Warning: Unused variable 't3' declared at (1) [-Wunused-variable] stat.h:8:35: Warning: Unused variable 't4' declared at (1) [-Wunused-variable] stat.h:8:39: Warning: Unused variable 't5' declared at (1) [-Wunused-variable] gfortran:f77: scipy/sparse/linalg/eigen/arpack/ARPACK/SRC/ssapps.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran stat.h:8:27: Warning: Unused variable 't2' declared at (1) [-Wunused-variable] stat.h:8:31: Warning: Unused variable 't3' declared at (1) [-Wunused-variable] stat.h:8:35: Warning: Unused variable 't4' declared at (1) [-Wunused-variable] stat.h:8:39: Warning: Unused variable 't5' declared at (1) [-Wunused-variable] gfortran:f77: scipy/sparse/linalg/eigen/arpack/ARPACK/SRC/ssortr.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/sparse/linalg/eigen/arpack/ARPACK/SRC/zneigh.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran stat.h:8:27: Warning: Unused variable 't2' declared at (1) [-Wunused-variable] stat.h:8:31: Warning: Unused variable 't3' declared at (1) [-Wunused-variable] stat.h:8:35: Warning: Unused variable 't4' declared at (1) [-Wunused-variable] stat.h:8:39: Warning: Unused variable 't5' declared at (1) [-Wunused-variable] gfortran:f77: scipy/sparse/linalg/eigen/arpack/ARPACK/SRC/cstatn.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran stat.h:8:19: Warning: Unused variable 't0' declared at (1) [-Wunused-variable] stat.h:8:23: Warning: Unused variable 't1' declared at (1) [-Wunused-variable] stat.h:8:27: Warning: Unused variable 't2' declared at (1) [-Wunused-variable] stat.h:8:31: Warning: Unused variable 't3' declared at (1) [-Wunused-variable] stat.h:8:35: Warning: Unused variable 't4' declared at (1) [-Wunused-variable] stat.h:8:39: Warning: Unused variable 't5' declared at (1) [-Wunused-variable] gfortran:f77: scipy/sparse/linalg/eigen/arpack/ARPACK/SRC/snaupd.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran scipy/sparse/linalg/eigen/arpack/ARPACK/SRC/snaupd.f:541:24: if (nb .le. 0) nb = 1 1 Warning: Nonconforming tab character at (1) [-Wtabs] scipy/sparse/linalg/eigen/arpack/ARPACK/SRC/snaupd.f:542:28: if (tol .le. zero) tol = wslamch('EpsMach') 1 Warning: Nonconforming tab character at (1) [-Wtabs] scipy/sparse/linalg/eigen/arpack/ARPACK/SRC/snaupd.f:447:32: & ldh, ldq, levec, mode, msglvl, mxiter, nb, 1 Warning: Unused variable 'levec' declared at (1) [-Wunused-variable] stat.h:8:27: Warning: Unused variable 't2' declared at (1) [-Wunused-variable] stat.h:8:31: Warning: Unused variable 't3' declared at (1) [-Wunused-variable] stat.h:8:35: Warning: Unused variable 't4' declared at (1) [-Wunused-variable] stat.h:8:39: Warning: Unused variable 't5' declared at (1) [-Wunused-variable] gfortran:f77: scipy/sparse/linalg/eigen/arpack/ARPACK/SRC/dnaupd.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran scipy/sparse/linalg/eigen/arpack/ARPACK/SRC/dnaupd.f:541:24: if (nb .le. 0) nb = 1 1 Warning: Nonconforming tab character at (1) [-Wtabs] scipy/sparse/linalg/eigen/arpack/ARPACK/SRC/dnaupd.f:542:28: if (tol .le. zero) tol = dlamch ('EpsMach') 1 Warning: Nonconforming tab character at (1) [-Wtabs] scipy/sparse/linalg/eigen/arpack/ARPACK/SRC/dnaupd.f:447:32: & ldh, ldq, levec, mode, msglvl, mxiter, nb, 1 Warning: Unused variable 'levec' declared at (1) [-Wunused-variable] stat.h:8:27: Warning: Unused variable 't2' declared at (1) [-Wunused-variable] stat.h:8:31: Warning: Unused variable 't3' declared at (1) [-Wunused-variable] stat.h:8:35: Warning: Unused variable 't4' declared at (1) [-Wunused-variable] stat.h:8:39: Warning: Unused variable 't5' declared at (1) [-Wunused-variable] gfortran:f77: scipy/sparse/linalg/eigen/arpack/ARPACK/SRC/sseigt.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran scipy/sparse/linalg/eigen/arpack/ARPACK/SRC/sseigt.f:124:18: integer i, k, msglvl 1 Warning: Unused variable 'i' declared at (1) [-Wunused-variable] stat.h:8:27: Warning: Unused variable 't2' declared at (1) [-Wunused-variable] stat.h:8:31: Warning: Unused variable 't3' declared at (1) [-Wunused-variable] stat.h:8:35: Warning: Unused variable 't4' declared at (1) [-Wunused-variable] stat.h:8:39: Warning: Unused variable 't5' declared at (1) [-Wunused-variable] gfortran:f77: scipy/sparse/linalg/eigen/arpack/ARPACK/SRC/dsaupd.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran stat.h:8:27: Warning: Unused variable 't2' declared at (1) [-Wunused-variable] stat.h:8:31: Warning: Unused variable 't3' declared at (1) [-Wunused-variable] stat.h:8:35: Warning: Unused variable 't4' declared at (1) [-Wunused-variable] stat.h:8:39: Warning: Unused variable 't5' declared at (1) [-Wunused-variable] gfortran:f77: scipy/sparse/linalg/eigen/arpack/ARPACK/SRC/cngets.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran stat.h:8:27: Warning: Unused variable 't2' declared at (1) [-Wunused-variable] stat.h:8:31: Warning: Unused variable 't3' declared at (1) [-Wunused-variable] stat.h:8:35: Warning: Unused variable 't4' declared at (1) [-Wunused-variable] stat.h:8:39: Warning: Unused variable 't5' declared at (1) [-Wunused-variable] gfortran:f77: scipy/sparse/linalg/eigen/arpack/ARPACK/SRC/dstatn.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran stat.h:8:19: Warning: Unused variable 't0' declared at (1) [-Wunused-variable] stat.h:8:23: Warning: Unused variable 't1' declared at (1) [-Wunused-variable] stat.h:8:27: Warning: Unused variable 't2' declared at (1) [-Wunused-variable] stat.h:8:31: Warning: Unused variable 't3' declared at (1) [-Wunused-variable] stat.h:8:35: Warning: Unused variable 't4' declared at (1) [-Wunused-variable] stat.h:8:39: Warning: Unused variable 't5' declared at (1) [-Wunused-variable] gfortran:f77: scipy/sparse/linalg/eigen/arpack/ARPACK/SRC/cnaupd.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran scipy/sparse/linalg/eigen/arpack/ARPACK/SRC/cnaupd.f:514:24: if (nb .le. 0) nb = 1 1 Warning: Nonconforming tab character at (1) [-Wtabs] scipy/sparse/linalg/eigen/arpack/ARPACK/SRC/cnaupd.f:515:32: if (tol .le. 0.0E+0 ) tol = wslamch('EpsMach') 1 Warning: Nonconforming tab character at (1) [-Wtabs] scipy/sparse/linalg/eigen/arpack/ARPACK/SRC/cnaupd.f:518:29: & ishift .ne. 2) ishift = 1 1 Warning: Nonconforming tab character at (1) [-Wtabs] scipy/sparse/linalg/eigen/arpack/ARPACK/SRC/cnaupd.f:422:32: & ldh, ldq, levec, mode, msglvl, mxiter, nb, 1 Warning: Unused variable 'levec' declared at (1) [-Wunused-variable] stat.h:8:27: Warning: Unused variable 't2' declared at (1) [-Wunused-variable] stat.h:8:31: Warning: Unused variable 't3' declared at (1) [-Wunused-variable] stat.h:8:35: Warning: Unused variable 't4' declared at (1) [-Wunused-variable] stat.h:8:39: Warning: Unused variable 't5' declared at (1) [-Wunused-variable] gfortran:f77: scipy/sparse/linalg/eigen/arpack/ARPACK/SRC/cgetv0.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran scipy/sparse/linalg/eigen/arpack/ARPACK/SRC/cgetv0.f:116:26: & ( ido, bmat, itry, initv, n, j, v, ldv, resid, rnorm, 1 Warning: Unused dummy argument 'itry' at (1) [-Wunused-dummy-argument] stat.h:8:35: Warning: Unused variable 't4' declared at (1) [-Wunused-variable] stat.h:8:39: Warning: Unused variable 't5' declared at (1) [-Wunused-variable] gfortran:f77: scipy/sparse/linalg/eigen/arpack/ARPACK/SRC/sgetv0.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran scipy/sparse/linalg/eigen/arpack/ARPACK/SRC/sgetv0.f:120:26: & ( ido, bmat, itry, initv, n, j, v, ldv, resid, rnorm, 1 Warning: Unused dummy argument 'itry' at (1) [-Wunused-dummy-argument] stat.h:8:35: Warning: Unused variable 't4' declared at (1) [-Wunused-variable] stat.h:8:39: Warning: Unused variable 't5' declared at (1) [-Wunused-variable] gfortran:f77: scipy/sparse/linalg/eigen/arpack/ARPACK/SRC/znaupd.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran scipy/sparse/linalg/eigen/arpack/ARPACK/SRC/znaupd.f:514:24: if (nb .le. 0) nb = 1 1 Warning: Nonconforming tab character at (1) [-Wtabs] scipy/sparse/linalg/eigen/arpack/ARPACK/SRC/znaupd.f:515:32: if (tol .le. 0.0D+0 ) tol = dlamch ('EpsMach') 1 Warning: Nonconforming tab character at (1) [-Wtabs] scipy/sparse/linalg/eigen/arpack/ARPACK/SRC/znaupd.f:518:29: & ishift .ne. 2) ishift = 1 1 Warning: Nonconforming tab character at (1) [-Wtabs] scipy/sparse/linalg/eigen/arpack/ARPACK/SRC/znaupd.f:422:32: & ldh, ldq, levec, mode, msglvl, mxiter, nb, 1 Warning: Unused variable 'levec' declared at (1) [-Wunused-variable] stat.h:8:27: Warning: Unused variable 't2' declared at (1) [-Wunused-variable] stat.h:8:31: Warning: Unused variable 't3' declared at (1) [-Wunused-variable] stat.h:8:35: Warning: Unused variable 't4' declared at (1) [-Wunused-variable] stat.h:8:39: Warning: Unused variable 't5' declared at (1) [-Wunused-variable] gfortran:f77: scipy/sparse/linalg/eigen/arpack/ARPACK/SRC/dsconv.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran stat.h:8:27: Warning: Unused variable 't2' declared at (1) [-Wunused-variable] stat.h:8:31: Warning: Unused variable 't3' declared at (1) [-Wunused-variable] stat.h:8:35: Warning: Unused variable 't4' declared at (1) [-Wunused-variable] stat.h:8:39: Warning: Unused variable 't5' declared at (1) [-Wunused-variable] gfortran:f77: scipy/sparse/linalg/eigen/arpack/ARPACK/SRC/sstats.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran stat.h:8:19: Warning: Unused variable 't0' declared at (1) [-Wunused-variable] stat.h:8:23: Warning: Unused variable 't1' declared at (1) [-Wunused-variable] stat.h:8:27: Warning: Unused variable 't2' declared at (1) [-Wunused-variable] stat.h:8:31: Warning: Unused variable 't3' declared at (1) [-Wunused-variable] stat.h:8:35: Warning: Unused variable 't4' declared at (1) [-Wunused-variable] stat.h:8:39: Warning: Unused variable 't5' declared at (1) [-Wunused-variable] gfortran:f77: scipy/sparse/linalg/eigen/arpack/ARPACK/SRC/zgetv0.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran scipy/sparse/linalg/eigen/arpack/ARPACK/SRC/zgetv0.f:116:26: & ( ido, bmat, itry, initv, n, j, v, ldv, resid, rnorm, 1 Warning: Unused dummy argument 'itry' at (1) [-Wunused-dummy-argument] stat.h:8:35: Warning: Unused variable 't4' declared at (1) [-Wunused-variable] stat.h:8:39: Warning: Unused variable 't5' declared at (1) [-Wunused-variable] gfortran:f77: scipy/sparse/linalg/eigen/arpack/ARPACK/SRC/csortc.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/sparse/linalg/eigen/arpack/ARPACK/SRC/zngets.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran stat.h:8:27: Warning: Unused variable 't2' declared at (1) [-Wunused-variable] stat.h:8:31: Warning: Unused variable 't3' declared at (1) [-Wunused-variable] stat.h:8:35: Warning: Unused variable 't4' declared at (1) [-Wunused-variable] stat.h:8:39: Warning: Unused variable 't5' declared at (1) [-Wunused-variable] gfortran:f77: scipy/sparse/linalg/eigen/arpack/ARPACK/SRC/ssaupd.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran stat.h:8:27: Warning: Unused variable 't2' declared at (1) [-Wunused-variable] stat.h:8:31: Warning: Unused variable 't3' declared at (1) [-Wunused-variable] stat.h:8:35: Warning: Unused variable 't4' declared at (1) [-Wunused-variable] stat.h:8:39: Warning: Unused variable 't5' declared at (1) [-Wunused-variable] gfortran:f77: scipy/sparse/linalg/eigen/arpack/ARPACK/SRC/dnaup2.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran scipy/sparse/linalg/eigen/arpack/ARPACK/SRC/dnaup2.f:316:5: 10 continue 1 Warning: Label 10 at (1) defined but not used [-Wunused-label] scipy/sparse/linalg/eigen/arpack/ARPACK/SRC/dnaup2.f:175:63: & ( ido, bmat, n, which, nev, np, tol, resid, mode, iupd, 1 Warning: Unused dummy argument 'iupd' at (1) [-Wunused-dummy-argument] stat.h:8:35: Warning: Unused variable 't4' declared at (1) [-Wunused-variable] stat.h:8:39: Warning: Unused variable 't5' declared at (1) [-Wunused-variable] gfortran:f77: scipy/sparse/linalg/eigen/arpack/ARPACK/SRC/ssconv.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran stat.h:8:27: Warning: Unused variable 't2' declared at (1) [-Wunused-variable] stat.h:8:31: Warning: Unused variable 't3' declared at (1) [-Wunused-variable] stat.h:8:35: Warning: Unused variable 't4' declared at (1) [-Wunused-variable] stat.h:8:39: Warning: Unused variable 't5' declared at (1) [-Wunused-variable] gfortran:f77: scipy/sparse/linalg/eigen/arpack/ARPACK/SRC/sngets.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran scipy/sparse/linalg/eigen/arpack/ARPACK/SRC/sngets.f:96:40: & shiftr, shifti ) 1 Warning: Unused dummy argument 'shifti' at (1) [-Wunused-dummy-argument] scipy/sparse/linalg/eigen/arpack/ARPACK/SRC/sngets.f:96:32: & shiftr, shifti ) 1 Warning: Unused dummy argument 'shiftr' at (1) [-Wunused-dummy-argument] stat.h:8:27: Warning: Unused variable 't2' declared at (1) [-Wunused-variable] stat.h:8:31: Warning: Unused variable 't3' declared at (1) [-Wunused-variable] stat.h:8:35: Warning: Unused variable 't4' declared at (1) [-Wunused-variable] stat.h:8:39: Warning: Unused variable 't5' declared at (1) [-Wunused-variable] gfortran:f77: scipy/sparse/linalg/eigen/arpack/ARPACK/SRC/znaitr.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran scipy/sparse/linalg/eigen/arpack/ARPACK/SRC/znaitr.f:209:33: & (ido, bmat, n, k, np, nb, resid, rnorm, v, ldv, h, ldh, 1 Warning: Unused dummy argument 'nb' at (1) [-Wunused-dummy-argument] gfortran:f77: scipy/sparse/linalg/eigen/arpack/ARPACK/SRC/dgetv0.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran scipy/sparse/linalg/eigen/arpack/ARPACK/SRC/dgetv0.f:120:26: & ( ido, bmat, itry, initv, n, j, v, ldv, resid, rnorm, 1 Warning: Unused dummy argument 'itry' at (1) [-Wunused-dummy-argument] stat.h:8:35: Warning: Unused variable 't4' declared at (1) [-Wunused-variable] stat.h:8:39: Warning: Unused variable 't5' declared at (1) [-Wunused-variable] gfortran:f77: scipy/sparse/linalg/eigen/arpack/ARPACK/SRC/cnaitr.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran scipy/sparse/linalg/eigen/arpack/ARPACK/SRC/cnaitr.f:209:33: & (ido, bmat, n, k, np, nb, resid, rnorm, v, ldv, h, ldh, 1 Warning: Unused dummy argument 'nb' at (1) [-Wunused-dummy-argument] gfortran:f77: scipy/sparse/linalg/eigen/arpack/ARPACK/SRC/sseupd.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran scipy/sparse/linalg/eigen/arpack/ARPACK/SRC/sseupd.f:499:17: jj = workl(bounds + ncv - j) 1 Warning: Possible change of value in conversion from REAL(4) to INTEGER(4) at (1) [-Wconversion] stat.h:8:19: Warning: Unused variable 't0' declared at (1) [-Wunused-variable] stat.h:8:23: Warning: Unused variable 't1' declared at (1) [-Wunused-variable] stat.h:8:27: Warning: Unused variable 't2' declared at (1) [-Wunused-variable] stat.h:8:31: Warning: Unused variable 't3' declared at (1) [-Wunused-variable] stat.h:8:35: Warning: Unused variable 't4' declared at (1) [-Wunused-variable] stat.h:8:39: Warning: Unused variable 't5' declared at (1) [-Wunused-variable] gfortran:f77: scipy/sparse/linalg/eigen/arpack/ARPACK/SRC/dnconv.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran stat.h:8:27: Warning: Unused variable 't2' declared at (1) [-Wunused-variable] stat.h:8:31: Warning: Unused variable 't3' declared at (1) [-Wunused-variable] stat.h:8:35: Warning: Unused variable 't4' declared at (1) [-Wunused-variable] stat.h:8:39: Warning: Unused variable 't5' declared at (1) [-Wunused-variable] gfortran:f77: scipy/sparse/linalg/eigen/arpack/ARPACK/SRC/ssesrt.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/sparse/linalg/eigen/arpack/ARPACK/SRC/sstqrb.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/sparse/linalg/eigen/arpack/ARPACK/SRC/dngets.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran scipy/sparse/linalg/eigen/arpack/ARPACK/SRC/dngets.f:96:40: & shiftr, shifti ) 1 Warning: Unused dummy argument 'shifti' at (1) [-Wunused-dummy-argument] scipy/sparse/linalg/eigen/arpack/ARPACK/SRC/dngets.f:96:32: & shiftr, shifti ) 1 Warning: Unused dummy argument 'shiftr' at (1) [-Wunused-dummy-argument] stat.h:8:27: Warning: Unused variable 't2' declared at (1) [-Wunused-variable] stat.h:8:31: Warning: Unused variable 't3' declared at (1) [-Wunused-variable] stat.h:8:35: Warning: Unused variable 't4' declared at (1) [-Wunused-variable] stat.h:8:39: Warning: Unused variable 't5' declared at (1) [-Wunused-variable] gfortran:f77: scipy/sparse/linalg/eigen/arpack/ARPACK/SRC/zsortc.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/sparse/linalg/eigen/arpack/ARPACK/SRC/ssortc.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/sparse/linalg/eigen/arpack/ARPACK/SRC/cnapps.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran stat.h:8:27: Warning: Unused variable 't2' declared at (1) [-Wunused-variable] stat.h:8:31: Warning: Unused variable 't3' declared at (1) [-Wunused-variable] stat.h:8:35: Warning: Unused variable 't4' declared at (1) [-Wunused-variable] stat.h:8:39: Warning: Unused variable 't5' declared at (1) [-Wunused-variable] gfortran:f77: scipy/sparse/linalg/eigen/arpack/ARPACK/SRC/dstats.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran stat.h:8:19: Warning: Unused variable 't0' declared at (1) [-Wunused-variable] stat.h:8:23: Warning: Unused variable 't1' declared at (1) [-Wunused-variable] stat.h:8:27: Warning: Unused variable 't2' declared at (1) [-Wunused-variable] stat.h:8:31: Warning: Unused variable 't3' declared at (1) [-Wunused-variable] stat.h:8:35: Warning: Unused variable 't4' declared at (1) [-Wunused-variable] stat.h:8:39: Warning: Unused variable 't5' declared at (1) [-Wunused-variable] gfortran:f77: scipy/sparse/linalg/eigen/arpack/ARPACK/SRC/ssgets.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran stat.h:8:27: Warning: Unused variable 't2' declared at (1) [-Wunused-variable] stat.h:8:31: Warning: Unused variable 't3' declared at (1) [-Wunused-variable] stat.h:8:35: Warning: Unused variable 't4' declared at (1) [-Wunused-variable] stat.h:8:39: Warning: Unused variable 't5' declared at (1) [-Wunused-variable] gfortran:f77: scipy/sparse/linalg/eigen/arpack/ARPACK/SRC/znapps.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran stat.h:8:27: Warning: Unused variable 't2' declared at (1) [-Wunused-variable] stat.h:8:31: Warning: Unused variable 't3' declared at (1) [-Wunused-variable] stat.h:8:35: Warning: Unused variable 't4' declared at (1) [-Wunused-variable] stat.h:8:39: Warning: Unused variable 't5' declared at (1) [-Wunused-variable] gfortran:f77: scipy/sparse/linalg/eigen/arpack/ARPACK/SRC/snaup2.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran scipy/sparse/linalg/eigen/arpack/ARPACK/SRC/snaup2.f:316:5: 10 continue 1 Warning: Label 10 at (1) defined but not used [-Wunused-label] scipy/sparse/linalg/eigen/arpack/ARPACK/SRC/snaup2.f:175:63: & ( ido, bmat, n, which, nev, np, tol, resid, mode, iupd, 1 Warning: Unused dummy argument 'iupd' at (1) [-Wunused-dummy-argument] stat.h:8:35: Warning: Unused variable 't4' declared at (1) [-Wunused-variable] stat.h:8:39: Warning: Unused variable 't5' declared at (1) [-Wunused-variable] gfortran:f77: scipy/sparse/linalg/eigen/arpack/ARPACK/SRC/snapps.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran stat.h:8:27: Warning: Unused variable 't2' declared at (1) [-Wunused-variable] stat.h:8:31: Warning: Unused variable 't3' declared at (1) [-Wunused-variable] stat.h:8:35: Warning: Unused variable 't4' declared at (1) [-Wunused-variable] stat.h:8:39: Warning: Unused variable 't5' declared at (1) [-Wunused-variable] gfortran:f77: scipy/sparse/linalg/eigen/arpack/ARPACK/SRC/sstatn.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran stat.h:8:19: Warning: Unused variable 't0' declared at (1) [-Wunused-variable] stat.h:8:23: Warning: Unused variable 't1' declared at (1) [-Wunused-variable] stat.h:8:27: Warning: Unused variable 't2' declared at (1) [-Wunused-variable] stat.h:8:31: Warning: Unused variable 't3' declared at (1) [-Wunused-variable] stat.h:8:35: Warning: Unused variable 't4' declared at (1) [-Wunused-variable] stat.h:8:39: Warning: Unused variable 't5' declared at (1) [-Wunused-variable] gfortran:f77: scipy/sparse/linalg/eigen/arpack/ARPACK/SRC/zstatn.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran stat.h:8:19: Warning: Unused variable 't0' declared at (1) [-Wunused-variable] stat.h:8:23: Warning: Unused variable 't1' declared at (1) [-Wunused-variable] stat.h:8:27: Warning: Unused variable 't2' declared at (1) [-Wunused-variable] stat.h:8:31: Warning: Unused variable 't3' declared at (1) [-Wunused-variable] stat.h:8:35: Warning: Unused variable 't4' declared at (1) [-Wunused-variable] stat.h:8:39: Warning: Unused variable 't5' declared at (1) [-Wunused-variable] gfortran:f77: scipy/sparse/linalg/eigen/arpack/ARPACK/SRC/sneigh.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran stat.h:8:27: Warning: Unused variable 't2' declared at (1) [-Wunused-variable] stat.h:8:31: Warning: Unused variable 't3' declared at (1) [-Wunused-variable] stat.h:8:35: Warning: Unused variable 't4' declared at (1) [-Wunused-variable] stat.h:8:39: Warning: Unused variable 't5' declared at (1) [-Wunused-variable] gfortran:f77: scipy/sparse/linalg/eigen/arpack/ARPACK/SRC/zneupd.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran scipy/sparse/linalg/eigen/arpack/ARPACK/SRC/zneupd.f:520:17: jj = workl(bounds + ncv - j) 1 Warning: Possible change of value in conversion from COMPLEX(8) to INTEGER(4) at (1) [-Wconversion] stat.h:8:19: Warning: Unused variable 't0' declared at (1) [-Wunused-variable] stat.h:8:23: Warning: Unused variable 't1' declared at (1) [-Wunused-variable] stat.h:8:27: Warning: Unused variable 't2' declared at (1) [-Wunused-variable] stat.h:8:31: Warning: Unused variable 't3' declared at (1) [-Wunused-variable] stat.h:8:35: Warning: Unused variable 't4' declared at (1) [-Wunused-variable] stat.h:8:39: Warning: Unused variable 't5' declared at (1) [-Wunused-variable] gfortran:f77: scipy/sparse/linalg/eigen/arpack/ARPACK/SRC/dseupd.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran scipy/sparse/linalg/eigen/arpack/ARPACK/SRC/dseupd.f:499:17: jj = workl(bounds + ncv - j) 1 Warning: Possible change of value in conversion from REAL(8) to INTEGER(4) at (1) [-Wconversion] stat.h:8:19: Warning: Unused variable 't0' declared at (1) [-Wunused-variable] stat.h:8:23: Warning: Unused variable 't1' declared at (1) [-Wunused-variable] stat.h:8:27: Warning: Unused variable 't2' declared at (1) [-Wunused-variable] stat.h:8:31: Warning: Unused variable 't3' declared at (1) [-Wunused-variable] stat.h:8:35: Warning: Unused variable 't4' declared at (1) [-Wunused-variable] stat.h:8:39: Warning: Unused variable 't5' declared at (1) [-Wunused-variable] gfortran:f77: scipy/sparse/linalg/eigen/arpack/ARPACK/SRC/dseigt.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran scipy/sparse/linalg/eigen/arpack/ARPACK/SRC/dseigt.f:124:18: integer i, k, msglvl 1 Warning: Unused variable 'i' declared at (1) [-Wunused-variable] stat.h:8:27: Warning: Unused variable 't2' declared at (1) [-Wunused-variable] stat.h:8:31: Warning: Unused variable 't3' declared at (1) [-Wunused-variable] stat.h:8:35: Warning: Unused variable 't4' declared at (1) [-Wunused-variable] stat.h:8:39: Warning: Unused variable 't5' declared at (1) [-Wunused-variable] gfortran:f77: scipy/sparse/linalg/eigen/arpack/ARPACK/SRC/dneupd.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran scipy/sparse/linalg/eigen/arpack/ARPACK/SRC/dneupd.f:587:17: jj = workl(bounds + ncv - j) 1 Warning: Possible change of value in conversion from REAL(8) to INTEGER(4) at (1) [-Wconversion] stat.h:8:19: Warning: Unused variable 't0' declared at (1) [-Wunused-variable] stat.h:8:23: Warning: Unused variable 't1' declared at (1) [-Wunused-variable] stat.h:8:27: Warning: Unused variable 't2' declared at (1) [-Wunused-variable] stat.h:8:31: Warning: Unused variable 't3' declared at (1) [-Wunused-variable] stat.h:8:35: Warning: Unused variable 't4' declared at (1) [-Wunused-variable] stat.h:8:39: Warning: Unused variable 't5' declared at (1) [-Wunused-variable] gfortran:f77: scipy/sparse/linalg/eigen/arpack/ARPACK/SRC/ssaitr.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/sparse/linalg/eigen/arpack/ARPACK/SRC/dsaitr.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/sparse/linalg/eigen/arpack/ARPACK/SRC/snaitr.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran scipy/sparse/linalg/eigen/arpack/ARPACK/SRC/snaitr.f:210:33: & (ido, bmat, n, k, np, nb, resid, rnorm, v, ldv, h, ldh, 1 Warning: Unused dummy argument 'nb' at (1) [-Wunused-dummy-argument] gfortran:f77: scipy/sparse/linalg/eigen/arpack/ARPACK/SRC/dsapps.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran stat.h:8:27: Warning: Unused variable 't2' declared at (1) [-Wunused-variable] stat.h:8:31: Warning: Unused variable 't3' declared at (1) [-Wunused-variable] stat.h:8:35: Warning: Unused variable 't4' declared at (1) [-Wunused-variable] stat.h:8:39: Warning: Unused variable 't5' declared at (1) [-Wunused-variable] gfortran:f77: scipy/sparse/linalg/eigen/arpack/ARPACK/SRC/ssaup2.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran scipy/sparse/linalg/eigen/arpack/ARPACK/SRC/ssaup2.f:809:5: 130 continue 1 Warning: Label 130 at (1) defined but not used [-Wunused-label] scipy/sparse/linalg/eigen/arpack/ARPACK/SRC/ssaup2.f:324:5: 10 continue 1 Warning: Label 10 at (1) defined but not used [-Wunused-label] scipy/sparse/linalg/eigen/arpack/ARPACK/SRC/ssaup2.f:180:63: & ( ido, bmat, n, which, nev, np, tol, resid, mode, iupd, 1 Warning: Unused dummy argument 'iupd' at (1) [-Wunused-dummy-argument] stat.h:8:35: Warning: Unused variable 't4' declared at (1) [-Wunused-variable] stat.h:8:39: Warning: Unused variable 't5' declared at (1) [-Wunused-variable] gfortran:f77: scipy/sparse/linalg/eigen/arpack/ARPACK/SRC/dsortc.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/sparse/linalg/eigen/arpack/ARPACK/SRC/dsaup2.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran scipy/sparse/linalg/eigen/arpack/ARPACK/SRC/dsaup2.f:810:5: 130 continue 1 Warning: Label 130 at (1) defined but not used [-Wunused-label] scipy/sparse/linalg/eigen/arpack/ARPACK/SRC/dsaup2.f:324:5: 10 continue 1 Warning: Label 10 at (1) defined but not used [-Wunused-label] scipy/sparse/linalg/eigen/arpack/ARPACK/SRC/dsaup2.f:180:63: & ( ido, bmat, n, which, nev, np, tol, resid, mode, iupd, 1 Warning: Unused dummy argument 'iupd' at (1) [-Wunused-dummy-argument] stat.h:8:35: Warning: Unused variable 't4' declared at (1) [-Wunused-variable] stat.h:8:39: Warning: Unused variable 't5' declared at (1) [-Wunused-variable] gfortran:f77: scipy/sparse/linalg/eigen/arpack/ARPACK/SRC/dnaitr.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran scipy/sparse/linalg/eigen/arpack/ARPACK/SRC/dnaitr.f:210:33: & (ido, bmat, n, k, np, nb, resid, rnorm, v, ldv, h, ldh, 1 Warning: Unused dummy argument 'nb' at (1) [-Wunused-dummy-argument] gfortran:f77: scipy/sparse/linalg/eigen/arpack/ARPACK/SRC/cneigh.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran stat.h:8:27: Warning: Unused variable 't2' declared at (1) [-Wunused-variable] stat.h:8:31: Warning: Unused variable 't3' declared at (1) [-Wunused-variable] stat.h:8:35: Warning: Unused variable 't4' declared at (1) [-Wunused-variable] stat.h:8:39: Warning: Unused variable 't5' declared at (1) [-Wunused-variable] gfortran:f77: scipy/sparse/linalg/eigen/arpack/ARPACK/SRC/snconv.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran stat.h:8:27: Warning: Unused variable 't2' declared at (1) [-Wunused-variable] stat.h:8:31: Warning: Unused variable 't3' declared at (1) [-Wunused-variable] stat.h:8:35: Warning: Unused variable 't4' declared at (1) [-Wunused-variable] stat.h:8:39: Warning: Unused variable 't5' declared at (1) [-Wunused-variable] gfortran:f77: scipy/sparse/linalg/eigen/arpack/ARPACK/SRC/dstqrb.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/sparse/linalg/eigen/arpack/ARPACK/SRC/dsortr.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/sparse/linalg/eigen/arpack/ARPACK/SRC/sneupd.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran scipy/sparse/linalg/eigen/arpack/ARPACK/SRC/sneupd.f:587:17: jj = workl(bounds + ncv - j) 1 Warning: Possible change of value in conversion from REAL(4) to INTEGER(4) at (1) [-Wconversion] stat.h:8:19: Warning: Unused variable 't0' declared at (1) [-Wunused-variable] stat.h:8:23: Warning: Unused variable 't1' declared at (1) [-Wunused-variable] stat.h:8:27: Warning: Unused variable 't2' declared at (1) [-Wunused-variable] stat.h:8:31: Warning: Unused variable 't3' declared at (1) [-Wunused-variable] stat.h:8:35: Warning: Unused variable 't4' declared at (1) [-Wunused-variable] stat.h:8:39: Warning: Unused variable 't5' declared at (1) [-Wunused-variable] gfortran:f77: scipy/sparse/linalg/eigen/arpack/ARPACK/SRC/dsesrt.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/sparse/linalg/eigen/arpack/ARPACK/SRC/dneigh.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran stat.h:8:27: Warning: Unused variable 't2' declared at (1) [-Wunused-variable] stat.h:8:31: Warning: Unused variable 't3' declared at (1) [-Wunused-variable] stat.h:8:35: Warning: Unused variable 't4' declared at (1) [-Wunused-variable] stat.h:8:39: Warning: Unused variable 't5' declared at (1) [-Wunused-variable] gfortran:f77: scipy/sparse/linalg/eigen/arpack/ARPACK/SRC/znaup2.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran scipy/sparse/linalg/eigen/arpack/ARPACK/SRC/znaup2.f:322:5: 10 continue 1 Warning: Label 10 at (1) defined but not used [-Wunused-label] scipy/sparse/linalg/eigen/arpack/ARPACK/SRC/znaup2.f:169:63: & ( ido, bmat, n, which, nev, np, tol, resid, mode, iupd, 1 Warning: Unused dummy argument 'iupd' at (1) [-Wunused-dummy-argument] stat.h:8:35: Warning: Unused variable 't4' declared at (1) [-Wunused-variable] stat.h:8:39: Warning: Unused variable 't5' declared at (1) [-Wunused-variable] gfortran:f77: scipy/sparse/linalg/eigen/arpack/ARPACK/UTIL/cvout.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/sparse/linalg/eigen/arpack/ARPACK/UTIL/iswap.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/sparse/linalg/eigen/arpack/ARPACK/UTIL/dmout.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/sparse/linalg/eigen/arpack/ARPACK/UTIL/svout.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/sparse/linalg/eigen/arpack/ARPACK/UTIL/iset.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran scipy/sparse/linalg/eigen/arpack/ARPACK/UTIL/iset.f:6:43: subroutine iset (n, value, array, inc) 1 Warning: Unused dummy argument 'inc' at (1) [-Wunused-dummy-argument] gfortran:f77: scipy/sparse/linalg/eigen/arpack/ARPACK/UTIL/zvout.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/sparse/linalg/eigen/arpack/ARPACK/UTIL/cmout.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/sparse/linalg/eigen/arpack/ARPACK/UTIL/icopy.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/sparse/linalg/eigen/arpack/ARPACK/UTIL/zmout.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/sparse/linalg/eigen/arpack/ARPACK/UTIL/icnteq.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/sparse/linalg/eigen/arpack/ARPACK/UTIL/ivout.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/sparse/linalg/eigen/arpack/ARPACK/UTIL/dvout.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/sparse/linalg/eigen/arpack/ARPACK/UTIL/second_NONE.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran scipy/sparse/linalg/eigen/arpack/ARPACK/UTIL/second_NONE.f:17:27: REAL T1 1 Warning: Unused variable 't1' declared at (1) [-Wunused-variable] scipy/sparse/linalg/eigen/arpack/ARPACK/UTIL/second_NONE.f:20:36: REAL TARRAY( 2 ) 1 Warning: Unused variable 'tarray' declared at (1) [-Wunused-variable] gfortran:f77: scipy/sparse/linalg/eigen/arpack/ARPACK/UTIL/smout.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: /builddir/build/BUILD/scipy-1.0.0/scipy/_build_utils/src/wrap_dummy_g77_abi.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: /builddir/build/BUILD/scipy-1.0.0/scipy/_build_utils/src/wrap_dummy_accelerate.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran ar: adding 50 object files to build/temp.linux-ppc64le-2.7/libarpack_scipy.a ar: adding 32 object files to build/temp.linux-ppc64le-2.7/libarpack_scipy.a building 'sc_c_misc' library compiling C sources C compiler: gcc -pthread -fno-strict-aliasing -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -D_GNU_SOURCE -fPIC -fwrapv -DNDEBUG -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -D_GNU_SOURCE -fPIC -fwrapv -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -fPIC creating build/temp.linux-ppc64le-2.7/scipy/special creating build/temp.linux-ppc64le-2.7/scipy/special/c_misc compile options: '-I/builddir/build/BUILD/scipy-1.0.0/scipy/special -I/usr/lib64/python2.7/site-packages/numpy/core/include -I/usr/include/python2.7 -I/builddir/build/BUILD/scipy-1.0.0/scipy/special/c_misc -I/usr/lib64/python2.7/site-packages/numpy/core/include -c' gcc: scipy/special/c_misc/poch.c gcc: scipy/special/c_misc/gammaincinv.c gcc: scipy/special/c_misc/gammasgn.c gcc: scipy/special/c_misc/besselpoly.c gcc: scipy/special/c_misc/struve.c gcc: scipy/special/c_misc/fsolve.c ar: adding 6 object files to build/temp.linux-ppc64le-2.7/libsc_c_misc.a building 'sc_cephes' library compiling C sources C compiler: gcc -pthread -fno-strict-aliasing -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -D_GNU_SOURCE -fPIC -fwrapv -DNDEBUG -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -D_GNU_SOURCE -fPIC -fwrapv -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -fPIC creating build/temp.linux-ppc64le-2.7/scipy/special/cephes compile options: '-I/builddir/build/BUILD/scipy-1.0.0/scipy/special -I/usr/lib64/python2.7/site-packages/numpy/core/include -I/usr/include/python2.7 -I/builddir/build/BUILD/scipy-1.0.0/scipy/special/c_misc -I/usr/lib64/python2.7/site-packages/numpy/core/include -c' gcc: scipy/special/cephes/ellie.c gcc: scipy/special/cephes/spence.c gcc: scipy/special/cephes/ndtri.c gcc: scipy/special/cephes/sindg.c gcc: scipy/special/cephes/struve.c gcc: scipy/special/cephes/nbdtr.c gcc: scipy/special/cephes/igami.c gcc: scipy/special/cephes/kn.c gcc: scipy/special/cephes/jv.c gcc: scipy/special/cephes/ellpk.c gcc: scipy/special/cephes/ellik.c gcc: scipy/special/cephes/hyp2f1.c gcc: scipy/special/cephes/i1.c gcc: scipy/special/cephes/exp10.c gcc: scipy/special/cephes/i0.c gcc: scipy/special/cephes/chbevl.c gcc: scipy/special/cephes/rgamma.c gcc: scipy/special/cephes/dawsn.c gcc: scipy/special/cephes/shichi.c gcc: scipy/special/cephes/cbrt.c gcc: scipy/special/cephes/psi.c gcc: scipy/special/cephes/igam.c In file included from scipy/special/cephes/igam.c:103: scipy/special/cephes/lanczos.h:116:15: warning: 'lanczos_sum_near_2_d' defined but not used [-Wunused-variable] static double lanczos_sum_near_2_d[12] = { ^~~~~~~~~~~~~~~~~~~~ scipy/special/cephes/lanczos.h:101:15: warning: 'lanczos_sum_near_1_d' defined but not used [-Wunused-variable] static double lanczos_sum_near_1_d[12] = { ^~~~~~~~~~~~~~~~~~~~ scipy/special/cephes/lanczos.h:85:15: warning: 'lanczos_sum_expg_scaled_denom' defined but not used [-Wunused-variable] static double lanczos_sum_expg_scaled_denom[13] = { ^~~~~~~~~~~~~~~~~~~~~~~~~~~~~ scipy/special/cephes/lanczos.h:69:15: warning: 'lanczos_sum_expg_scaled_num' defined but not used [-Wunused-variable] static double lanczos_sum_expg_scaled_num[13] = { ^~~~~~~~~~~~~~~~~~~~~~~~~~~ scipy/special/cephes/lanczos.h:53:15: warning: 'lanczos_denom' defined but not used [-Wunused-variable] static double lanczos_denom[13] = { ^~~~~~~~~~~~~ scipy/special/cephes/lanczos.h:37:15: warning: 'lanczos_num' defined but not used [-Wunused-variable] static double lanczos_num[13] = { ^~~~~~~~~~~ gcc: scipy/special/cephes/hyperg.c gcc: scipy/special/cephes/chdtr.c gcc: scipy/special/cephes/round.c gcc: scipy/special/cephes/mtherr.c gcc: scipy/special/cephes/kolmogorov.c gcc: scipy/special/cephes/gdtr.c gcc: scipy/special/cephes/incbi.c gcc: scipy/special/cephes/airy.c gcc: scipy/special/cephes/incbet.c gcc: scipy/special/cephes/exp2.c gcc: scipy/special/cephes/zetac.c gcc: scipy/special/cephes/yn.c gcc: scipy/special/cephes/gamma.c gcc: scipy/special/cephes/sincos.c gcc: scipy/special/cephes/stdtr.c gcc: scipy/special/cephes/sici.c gcc: scipy/special/cephes/btdtr.c gcc: scipy/special/cephes/scipy_iv.c gcc: scipy/special/cephes/tandg.c gcc: scipy/special/cephes/zeta.c gcc: scipy/special/cephes/ellpj.c gcc: scipy/special/cephes/j0.c gcc: scipy/special/cephes/tukey.c gcc: scipy/special/cephes/gels.c gcc: scipy/special/cephes/fresnl.c gcc: scipy/special/cephes/j1.c gcc: scipy/special/cephes/const.c gcc: scipy/special/cephes/fdtr.c gcc: scipy/special/cephes/pdtr.c gcc: scipy/special/cephes/ellpe.c gcc: scipy/special/cephes/lanczos.c In file included from scipy/special/cephes/lanczos.c:13: scipy/special/cephes/lanczos.h:131:15: warning: 'lanczos_g' defined but not used [-Wunused-variable] static double lanczos_g = 6.024680040776729583740234375; ^~~~~~~~~ gcc: scipy/special/cephes/ndtr.c gcc: scipy/special/cephes/expn.c gcc: scipy/special/cephes/bdtr.c gcc: scipy/special/cephes/k0.c gcc: scipy/special/cephes/k1.c gcc: scipy/special/cephes/unity.c gcc: scipy/special/cephes/beta.c ar: adding 50 object files to build/temp.linux-ppc64le-2.7/libsc_cephes.a ar: adding 10 object files to build/temp.linux-ppc64le-2.7/libsc_cephes.a building 'sc_mach' library using additional config_fc from setup script for fortran compiler: {'noopt': ('scipy/special/setup.py', 1)} customize Gnu95FCompiler compiling Fortran sources Fortran f77 compiler: /usr/bin/gfortran -Wall -g -ffixed-form -fno-second-underscore -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -fPIC -cpp Fortran f90 compiler: /usr/bin/gfortran -Wall -g -fno-second-underscore -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -fPIC -cpp Fortran fix compiler: /usr/bin/gfortran -Wall -g -ffixed-form -fno-second-underscore -Wall -g -fno-second-underscore -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -fPIC -cpp creating build/temp.linux-ppc64le-2.7/scipy/special/mach compile options: '-I/usr/lib64/python2.7/site-packages/numpy/core/include -c' gfortran:f77: scipy/special/mach/i1mach.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/special/mach/xerror.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran scipy/special/mach/xerror.f:1:37: SUBROUTINE XERROR(MESS,NMESS,L1,L2) 1 Warning: Unused dummy argument 'l1' at (1) [-Wunused-dummy-argument] scipy/special/mach/xerror.f:1:40: SUBROUTINE XERROR(MESS,NMESS,L1,L2) 1 Warning: Unused dummy argument 'l2' at (1) [-Wunused-dummy-argument] gfortran:f77: scipy/special/mach/d1mach.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran ar: adding 3 object files to build/temp.linux-ppc64le-2.7/libsc_mach.a building 'sc_amos' library compiling Fortran sources Fortran f77 compiler: /usr/bin/gfortran -Wall -g -ffixed-form -fno-second-underscore -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -fPIC -cpp -O3 -funroll-loops Fortran f90 compiler: /usr/bin/gfortran -Wall -g -fno-second-underscore -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -fPIC -cpp -O3 -funroll-loops Fortran fix compiler: /usr/bin/gfortran -Wall -g -ffixed-form -fno-second-underscore -Wall -g -fno-second-underscore -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -fPIC -cpp -O3 -funroll-loops creating build/temp.linux-ppc64le-2.7/scipy/special/amos compile options: '-I/usr/lib64/python2.7/site-packages/numpy/core/include -c' gfortran:f77: scipy/special/amos/zasyi.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/special/amos/zbesh.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/special/amos/zmlt.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/special/amos/zacai.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/special/amos/zairy.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/special/amos/zuoik.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/special/amos/zseri.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/special/amos/zbknu.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran scipy/special/amos/zbknu.f:426:0: S2I = CKI*P2R + CKR*P2I + S1I Warning: 'cki' may be used uninitialized in this function [-Wmaybe-uninitialized] scipy/special/amos/zbknu.f:425:0: S2R = CKR*P2R - CKI*P2I + S1R Warning: 'ckr' may be used uninitialized in this function [-Wmaybe-uninitialized] gfortran:f77: scipy/special/amos/zuchk.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/special/amos/zbiry.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/special/amos/zunhj.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/special/amos/zbesi.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/special/amos/dgamln.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran scipy/special/amos/dgamln.f:188:0: RETURN Warning: '__result_dgamln' may be used uninitialized in this function [-Wmaybe-uninitialized] scipy/special/amos/dgamln.f:155:0: ZINC = ZMIN - FLOAT(NZ) Warning: 'nz' may be used uninitialized in this function [-Wmaybe-uninitialized] gfortran:f77: scipy/special/amos/zabs.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/special/amos/zuni1.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/special/amos/zexp.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/special/amos/zacon.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran scipy/special/amos/zacon.f:166:0: S1R = SC1R*CSSR(KFLAG) Warning: 'sc2r' may be used uninitialized in this function [-Wmaybe-uninitialized] scipy/special/amos/zacon.f:167:0: S1I = SC1I*CSSR(KFLAG) Warning: 'sc2i' may be used uninitialized in this function [-Wmaybe-uninitialized] gfortran:f77: scipy/special/amos/zunk2.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran scipy/special/amos/zunk2.f:30:0: INTEGER I, IB, IFLAG, IFN, IL, IN, INU, IUF, K, KDFLG, KFLAG, KK, Warning: 'iflag' may be used uninitialized in this function [-Wmaybe-uninitialized] scipy/special/amos/zunk2.f:253:0: C1R = CSRR(KFLAG) Warning: 'kflag' may be used uninitialized in this function [-Wmaybe-uninitialized] gfortran:f77: scipy/special/amos/zbunk.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/special/amos/zunk1.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran scipy/special/amos/zunk1.f:23:0: INTEGER I, IB, IFLAG, IFN, IL, INIT, INU, IUF, K, KDFLG, KFLAG, Warning: 'iflag' may be used uninitialized in this function [-Wmaybe-uninitialized] scipy/special/amos/zunk1.f:198:0: C1R = CSRR(KFLAG) Warning: 'kflag' may be used uninitialized in this function [-Wmaybe-uninitialized] gfortran:f77: scipy/special/amos/zbesk.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/special/amos/zlog.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/special/amos/zs1s2.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/special/amos/zwrsk.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/special/amos/zdiv.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/special/amos/zkscl.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/special/amos/zsqrt.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/special/amos/zshch.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/special/amos/zunik.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/special/amos/zuni2.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/special/amos/zbesj.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/special/amos/zmlri.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/special/amos/zbesy.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran scipy/special/amos/zbesy.f:183:13: R1M5 = D1MACH(5) 1 Warning: Possible change of value in conversion from REAL(8) to REAL(4) at (1) [-Wconversion] gfortran:f77: scipy/special/amos/zbinu.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/special/amos/zrati.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/special/amos/zbuni.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran ar: adding 36 object files to build/temp.linux-ppc64le-2.7/libsc_amos.a building 'sc_cdf' library compiling Fortran sources Fortran f77 compiler: /usr/bin/gfortran -Wall -g -ffixed-form -fno-second-underscore -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -fPIC -cpp -O3 -funroll-loops Fortran f90 compiler: /usr/bin/gfortran -Wall -g -fno-second-underscore -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -fPIC -cpp -O3 -funroll-loops Fortran fix compiler: /usr/bin/gfortran -Wall -g -ffixed-form -fno-second-underscore -Wall -g -fno-second-underscore -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -fPIC -cpp -O3 -funroll-loops creating build/temp.linux-ppc64le-2.7/scipy/special/cdflib compile options: '-I/usr/lib64/python2.7/site-packages/numpy/core/include -c' gfortran:f77: scipy/special/cdflib/cdfchi.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran scipy/special/cdflib/cdfchi.f:177:0: IF (porq.GT.1.5D0) THEN Warning: 'porq' may be used uninitialized in this function [-Wmaybe-uninitialized] gfortran:f77: scipy/special/cdflib/cumnor.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/special/cdflib/ipmpar.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/special/cdflib/alngam.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/special/cdflib/stvaln.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/special/cdflib/basym.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/special/cdflib/apser.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/special/cdflib/cdft.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/special/cdflib/fpser.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/special/cdflib/devlpl.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/special/cdflib/gratio.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/special/cdflib/cumfnc.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran scipy/special/cdflib/cumfnc.f:117:14: icent = xnonc 1 Warning: Possible change of value in conversion from REAL(8) to INTEGER(4) at (1) [-Wconversion] gfortran:f77: scipy/special/cdflib/dt1.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/special/cdflib/dinvnr.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/special/cdflib/exparg.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/special/cdflib/cumnbn.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/special/cdflib/cumtnc.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/special/cdflib/cumf.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/special/cdflib/dzror.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran scipy/special/cdflib/dzror.f:93:72: ASSIGN 10 TO i99999 1 Warning: Deleted feature: ASSIGN statement at (1) scipy/special/cdflib/dzror.f:101:72: ASSIGN 20 TO i99999 1 Warning: Deleted feature: ASSIGN statement at (1) scipy/special/cdflib/dzror.f:182:72: ASSIGN 200 TO i99999 1 Warning: Deleted feature: ASSIGN statement at (1) scipy/special/cdflib/dzror.f:311:72: GO TO i99999 1 Warning: Deleted feature: Assigned GOTO statement at (1) scipy/special/cdflib/dzror.f:185:5: 200 fb = fx 1 Warning: Label 200 at (1) defined but not used [-Wunused-label] scipy/special/cdflib/dzror.f:107:5: 20 IF (.NOT. (fb.LT.0.0D0)) GO TO 40 1 Warning: Label 20 at (1) defined but not used [-Wunused-label] scipy/special/cdflib/dzror.f:96:5: 10 fb = fx 1 Warning: Label 10 at (1) defined but not used [-Wunused-label] gfortran:f77: scipy/special/cdflib/brcomp.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran scipy/special/cdflib/brcomp.f:78:10: n = b0 - 1.0D0 1 Warning: Possible change of value in conversion from REAL(8) to INTEGER(4) at (1) [-Wconversion] gfortran:f77: scipy/special/cdflib/gam1.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/special/cdflib/erf.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran scipy/special/cdflib/erf.f:1:6: DOUBLE PRECISION FUNCTION erf(x) 1 Warning: 'erf' declared at (1) is also the name of an intrinsic. It can only be called via an explicit interface or if declared EXTERNAL. [-Wintrinsic-shadow] gfortran:f77: scipy/special/cdflib/gamma_fort.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran scipy/special/cdflib/gamma_fort.f:1:6: DOUBLE PRECISION FUNCTION gamma(a) 1 Warning: 'gamma' declared at (1) is also the name of an intrinsic. It can only be called via an explicit interface or if declared EXTERNAL. [-Wintrinsic-shadow] scipy/special/cdflib/gamma_fort.f:124:10: n = x 1 Warning: Possible change of value in conversion from REAL(8) to INTEGER(4) at (1) [-Wconversion] scipy/special/cdflib/gamma_fort.f:149:0: IF (a.LT.0.0D0) gamma = (1.0D0/ (gamma*s))/x Warning: 's' may be used uninitialized in this function [-Wmaybe-uninitialized] gfortran:f77: scipy/special/cdflib/cdfbet.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/special/cdflib/rexp.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/special/cdflib/gsumln.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/special/cdflib/betaln.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran scipy/special/cdflib/betaln.f:55:10: n = a - 1.0D0 1 Warning: Possible change of value in conversion from REAL(8) to INTEGER(4) at (1) [-Wconversion] scipy/special/cdflib/betaln.f:69:10: 60 n = b - 1.0D0 1 Warning: Possible change of value in conversion from REAL(8) to INTEGER(4) at (1) [-Wconversion] scipy/special/cdflib/betaln.f:80:10: 80 n = a - 1.0D0 1 Warning: Possible change of value in conversion from REAL(8) to INTEGER(4) at (1) [-Wconversion] gfortran:f77: scipy/special/cdflib/gaminv.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran scipy/special/cdflib/gaminv.f:168:0: IF (b.GT.bmin(iop)) GO TO 220 Warning: 'b' may be used uninitialized in this function [-Wmaybe-uninitialized] gfortran:f77: scipy/special/cdflib/cdfgam.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/special/cdflib/cdfnbn.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/special/cdflib/cumchi.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/special/cdflib/cdff.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/special/cdflib/gamln1.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/special/cdflib/cumgam.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/special/cdflib/bfrac.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/special/cdflib/alnrel.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/special/cdflib/cumbin.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/special/cdflib/cumbet.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/special/cdflib/bcorr.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/special/cdflib/cdfchn.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/special/cdflib/cumchn.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/special/cdflib/cumpoi.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/special/cdflib/cumt.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/special/cdflib/cdffnc.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/special/cdflib/brcmp1.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran scipy/special/cdflib/brcmp1.f:77:10: n = b0 - 1.0D0 1 Warning: Possible change of value in conversion from REAL(8) to INTEGER(4) at (1) [-Wconversion] gfortran:f77: scipy/special/cdflib/rcomp.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/special/cdflib/esum.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/special/cdflib/cdfnor.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/special/cdflib/dinvr.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran scipy/special/cdflib/dinvr.f:100:72: ASSIGN 10 TO i99999 1 Warning: Deleted feature: ASSIGN statement at (1) scipy/special/cdflib/dinvr.f:106:72: ASSIGN 20 TO i99999 1 Warning: Deleted feature: ASSIGN statement at (1) scipy/special/cdflib/dinvr.f:143:72: ASSIGN 90 TO i99999 1 Warning: Deleted feature: ASSIGN statement at (1) scipy/special/cdflib/dinvr.f:168:72: ASSIGN 130 TO i99999 1 Warning: Deleted feature: ASSIGN statement at (1) scipy/special/cdflib/dinvr.f:203:72: ASSIGN 200 TO i99999 1 Warning: Deleted feature: ASSIGN statement at (1) scipy/special/cdflib/dinvr.f:238:72: ASSIGN 270 TO i99999 1 Warning: Deleted feature: ASSIGN statement at (1) scipy/special/cdflib/dinvr.f:379:72: GO TO i99999 1 Warning: Deleted feature: Assigned GOTO statement at (1) scipy/special/cdflib/dinvr.f:241:5: 270 CONTINUE 1 Warning: Label 270 at (1) defined but not used [-Wunused-label] scipy/special/cdflib/dinvr.f:206:5: 200 yy = fx 1 Warning: Label 200 at (1) defined but not used [-Wunused-label] scipy/special/cdflib/dinvr.f:171:5: 130 yy = fx 1 Warning: Label 130 at (1) defined but not used [-Wunused-label] scipy/special/cdflib/dinvr.f:146:5: 90 yy = fx 1 Warning: Label 90 at (1) defined but not used [-Wunused-label] scipy/special/cdflib/dinvr.f:109:5: 20 fbig = fx 1 Warning: Label 20 at (1) defined but not used [-Wunused-label] scipy/special/cdflib/dinvr.f:103:5: 10 fsmall = fx 1 Warning: Label 10 at (1) defined but not used [-Wunused-label] gfortran:f77: scipy/special/cdflib/grat1.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/special/cdflib/algdiv.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/special/cdflib/bgrat.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/special/cdflib/bratio.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran scipy/special/cdflib/bratio.f:166:10: 160 n = b0 1 Warning: Possible change of value in conversion from REAL(8) to INTEGER(4) at (1) [-Wconversion] gfortran:f77: scipy/special/cdflib/cdftnc.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/special/cdflib/cdfbin.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/special/cdflib/cdfpoi.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/special/cdflib/rlog1.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/special/cdflib/bpser.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran scipy/special/cdflib/bpser.f:57:10: m = b0 - 1.0D0 1 Warning: Possible change of value in conversion from REAL(8) to INTEGER(4) at (1) [-Wconversion] gfortran:f77: scipy/special/cdflib/bup.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran scipy/special/cdflib/bup.f:32:11: mu = abs(exparg(1)) 1 Warning: Possible change of value in conversion from REAL(8) to INTEGER(4) at (1) [-Wconversion] scipy/special/cdflib/bup.f:33:10: k = exparg(0) 1 Warning: Possible change of value in conversion from REAL(8) to INTEGER(4) at (1) [-Wconversion] scipy/special/cdflib/bup.f:55:22: IF (r.LT.t) k = r 1 Warning: Possible change of value in conversion from REAL(8) to INTEGER(4) at (1) [-Wconversion] gfortran:f77: scipy/special/cdflib/rlog.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/special/cdflib/spmpar.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/special/cdflib/gamln.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran scipy/special/cdflib/gamln.f:44:10: n = a - 1.25D0 1 Warning: Possible change of value in conversion from REAL(8) to INTEGER(4) at (1) [-Wconversion] gfortran:f77: scipy/special/cdflib/psi_fort.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/special/cdflib/erfc1.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran ar: adding 50 object files to build/temp.linux-ppc64le-2.7/libsc_cdf.a ar: adding 14 object files to build/temp.linux-ppc64le-2.7/libsc_cdf.a building 'sc_specfun' library compiling Fortran sources Fortran f77 compiler: /usr/bin/gfortran -Wall -g -ffixed-form -fno-second-underscore -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -fPIC -cpp -O3 -funroll-loops Fortran f90 compiler: /usr/bin/gfortran -Wall -g -fno-second-underscore -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -fPIC -cpp -O3 -funroll-loops Fortran fix compiler: /usr/bin/gfortran -Wall -g -ffixed-form -fno-second-underscore -Wall -g -fno-second-underscore -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -fPIC -cpp -O3 -funroll-loops creating build/temp.linux-ppc64le-2.7/scipy/special/specfun compile options: '-I/usr/lib64/python2.7/site-packages/numpy/core/include -c' gfortran:f77: scipy/special/specfun/specfun.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran scipy/special/specfun/specfun.f:4939:17: M1=X-1 1 Warning: Possible change of value in conversion from REAL(8) to INTEGER(4) at (1) [-Wconversion] scipy/special/specfun/specfun.f:1227:14: NN=N1-(N1-N0)/(1.0D0-F0/F1) 1 Warning: Possible change of value in conversion from REAL(8) to INTEGER(4) at (1) [-Wconversion] scipy/special/specfun/specfun.f:1266:14: NN=N1-(N1-N0)/(1.0D0-F0/F1) 1 Warning: Possible change of value in conversion from REAL(8) to INTEGER(4) at (1) [-Wconversion] scipy/special/specfun/specfun.f:1590:13: N=XA 1 Warning: Possible change of value in conversion from REAL(8) to INTEGER(4) at (1) [-Wconversion] scipy/special/specfun/specfun.f:1595:13: N=XA-.5 1 Warning: Possible change of value in conversion from REAL(8) to INTEGER(4) at (1) [-Wconversion] scipy/special/specfun/specfun.f:8234:11: ID=15-ABS(D1-D2) 1 Warning: Possible change of value in conversion from REAL(8) to INTEGER(4) at (1) [-Wconversion] scipy/special/specfun/specfun.f:9419:20: IF (IL1) NM=ABS(A) 1 Warning: Possible change of value in conversion from REAL(8) to INTEGER(4) at (1) [-Wconversion] scipy/special/specfun/specfun.f:9420:20: IF (IL2) NM=ABS(AA) 1 Warning: Possible change of value in conversion from REAL(8) to INTEGER(4) at (1) [-Wconversion] scipy/special/specfun/specfun.f:9442:14: 20 ID=ABS(LOG10(RA)) 1 Warning: Possible change of value in conversion from REAL(8) to INTEGER(4) at (1) [-Wconversion] scipy/special/specfun/specfun.f:9913:10: N=ABS(B-1) 1 Warning: Possible change of value in conversion from REAL(8) to INTEGER(4) at (1) [-Wconversion] scipy/special/specfun/specfun.f:9953:11: ID=15-ABS(DA1-DA2) 1 Warning: Possible change of value in conversion from REAL(8) to INTEGER(4) at (1) [-Wconversion] scipy/special/specfun/specfun.f:9988:12: ID1=15-ABS(DB1-DB2) 1 Warning: Possible change of value in conversion from REAL(8) to INTEGER(4) at (1) [-Wconversion] scipy/special/specfun/specfun.f:8814:2: scipy/special/specfun/specfun.f:8774:72: IF (JM+1.GT.251) GOTO 6 2 scipy/special/specfun/specfun.f:8814:2: 6 FNAN=DNAN() 1 Warning: Legacy Extension: Label at (1) is not in the same block as the GOTO statement at (2) scipy/special/specfun/specfun.f:5635:34: DOUBLE COMPLEX Z, CEI, IMF 1 Warning: Unused variable 'imf' declared at (1) [-Wunused-variable] scipy/special/specfun/specfun.f:8774:0: IF (JM+1.GT.251) GOTO 6 Warning: 'jm' may be used uninitialized in this function [-Wmaybe-uninitialized] scipy/special/specfun/specfun.f:12830:0: IF (CDABS((CS-CW)/CS).LT.1.0D-15) GO TO 45 Warning: 'IMAGPART_EXPR ' may be used uninitialized in this function [-Wmaybe-uninitialized] scipy/special/specfun/specfun.f:12830:0: Warning: 'REALPART_EXPR ' may be used uninitialized in this function [-Wmaybe-uninitialized] scipy/special/specfun/specfun.f:6854:0: CF=2.0D0*(K+1.0D0)/Z*CF1-CF2 Warning: 'IMAGPART_EXPR ' may be used uninitialized in this function [-Wmaybe-uninitialized] scipy/special/specfun/specfun.f:6854:0: Warning: 'REALPART_EXPR ' may be used uninitialized in this function [-Wmaybe-uninitialized] scipy/special/specfun/specfun.f:12480:0: CS0=CDEXP(Z1)/(CBS-CF) Warning: 'IMAGPART_EXPR ' may be used uninitialized in this function [-Wmaybe-uninitialized] scipy/special/specfun/specfun.f:12480:0: Warning: 'REALPART_EXPR ' may be used uninitialized in this function [-Wmaybe-uninitialized] scipy/special/specfun/specfun.f:1190:0: 20 CSJ(K)=CS*CSJ(K) Warning: 'IMAGPART_EXPR ' may be used uninitialized in this function [-Wmaybe-uninitialized] scipy/special/specfun/specfun.f:1190:0: Warning: 'REALPART_EXPR ' may be used uninitialized in this function [-Wmaybe-uninitialized] scipy/special/specfun/specfun.f:1480:0: CDYV=-V/Z*CBYV+CFY Warning: 'IMAGPART_EXPR ' may be used uninitialized in this function [-Wmaybe-uninitialized] scipy/special/specfun/specfun.f:1480:0: Warning: 'REALPART_EXPR ' may be used uninitialized in this function [-Wmaybe-uninitialized] scipy/special/specfun/specfun.f:2102:0: XS=BJ(1) Warning: 'bj[0]' may be used uninitialized in this function [-Wmaybe-uninitialized] scipy/special/specfun/specfun.f:2269:0: CQF0=CQ0 Warning: 'IMAGPART_EXPR ' may be used uninitialized in this function [-Wmaybe-uninitialized] scipy/special/specfun/specfun.f:2269:0: Warning: 'REALPART_EXPR ' may be used uninitialized in this function [-Wmaybe-uninitialized] scipy/special/specfun/specfun.f:2392:0: & + U1*(-108056875D0/6967296D0))))) Warning: 'u1' may be used uninitialized in this function [-Wmaybe-uninitialized] scipy/special/specfun/specfun.f:2375:0: U=3.0D0*PI*(4.0D0*I-1)/8.0D0 Warning: 'u' may be used uninitialized in this function [-Wmaybe-uninitialized] scipy/special/specfun/specfun.f:3583:0: CBY(LB+1)=(CBJ(LB+1)*CYV0-2.0D0*CP11/(PI*Z))/CBJ(0) Warning: 'IMAGPART_EXPR ' may be used uninitialized in this function [-Wmaybe-uninitialized] scipy/special/specfun/specfun.f:3583:0: Warning: 'REALPART_EXPR ' may be used uninitialized in this function [-Wmaybe-uninitialized] scipy/special/specfun/specfun.f:3520:0: CF=2.0D0*(K+V0-1.0D0)/Z*CF1-CF0 Warning: 'IMAGPART_EXPR ' may be used uninitialized in this function [-Wmaybe-uninitialized] scipy/special/specfun/specfun.f:3520:0: Warning: 'REALPART_EXPR ' may be used uninitialized in this function [-Wmaybe-uninitialized] scipy/special/specfun/specfun.f:3477:0: CYV0=(CJV0*DCOS(PV0)-CJU0)/DSIN(PV0) Warning: 'IMAGPART_EXPR ' may be used uninitialized in this function [-Wmaybe-uninitialized] scipy/special/specfun/specfun.f:3477:0: Warning: 'REALPART_EXPR ' may be used uninitialized in this function [-Wmaybe-uninitialized] scipy/special/specfun/specfun.f:3456:0: CYV1=CA0*(CPZ*CSK+CQZ*CCK) Warning: 'IMAGPART_EXPR ' may be used uninitialized in this function [-Wmaybe-uninitialized] scipy/special/specfun/specfun.f:3504:0: CYV1=CFAC1*CYV1-2.0D0*CI*DCOS(PV1)*CJV1 Warning: 'REALPART_EXPR ' may be used uninitialized in this function [-Wmaybe-uninitialized] scipy/special/specfun/specfun.f:3453:0: CYV0=CA0*(CPZ*CSK+CQZ*CCK) Warning: 'IMAGPART_EXPR ' may be used uninitialized in this function [-Wmaybe-uninitialized] scipy/special/specfun/specfun.f:3503:0: CYV0=CFAC0*CYV0-2.0D0*CI*DCOS(PV0)*CJV0 Warning: 'REALPART_EXPR ' may be used uninitialized in this function [-Wmaybe-uninitialized] scipy/special/specfun/specfun.f:3556:0: YA1=CDABS(CG0) Warning: 'cg0' may be used uninitialized in this function [-Wmaybe-uninitialized] scipy/special/specfun/specfun.f:3548:0: YA0=CDABS(CYV0) Warning: 'cyv0' may be used uninitialized in this function [-Wmaybe-uninitialized] scipy/special/specfun/specfun.f:3503:0: CYV0=CFAC0*CYV0-2.0D0*CI*DCOS(PV0)*CJV0 Warning: 'IMAGPART_EXPR ' may be used uninitialized in this function [-Wmaybe-uninitialized] scipy/special/specfun/specfun.f:3503:0: Warning: 'REALPART_EXPR ' may be used uninitialized in this function [-Wmaybe-uninitialized] scipy/special/specfun/specfun.f:3538:0: IF (CDABS(CJV0).GT.CDABS(CJV1)) CS=CJV0/CF Warning: 'cjv0' may be used uninitialized in this function [-Wmaybe-uninitialized] scipy/special/specfun/specfun.f:3739:0: CF=2.0D0*(V0+K+1.0D0)/Z1*CF1-CF2 Warning: 'IMAGPART_EXPR ' may be used uninitialized in this function [-Wmaybe-uninitialized] scipy/special/specfun/specfun.f:3739:0: Warning: 'REALPART_EXPR ' may be used uninitialized in this function [-Wmaybe-uninitialized] scipy/special/specfun/specfun.f:3701:0: CYV0=CA0*(CPZ*CSK+CQZ*CCK) Warning: 'IMAGPART_EXPR ' may be used uninitialized in this function [-Wmaybe-uninitialized] scipy/special/specfun/specfun.f:3749:0: CYV0=CFAC0*CYV0-2.0D0*CI*DCOS(PV0)*CJV0 Warning: 'REALPART_EXPR ' may be used uninitialized in this function [-Wmaybe-uninitialized] scipy/special/specfun/specfun.f:4737:0: IF (L.EQ.0) PD0=PD1 Warning: 'pd1' may be used uninitialized in this function [-Wmaybe-uninitialized] scipy/special/specfun/specfun.f:5473:0: CDKV=-CFK-V/Z*CBKV Warning: 'IMAGPART_EXPR ' may be used uninitialized in this function [-Wmaybe-uninitialized] scipy/special/specfun/specfun.f:5473:0: Warning: 'REALPART_EXPR ' may be used uninitialized in this function [-Wmaybe-uninitialized] scipy/special/specfun/specfun.f:6160:0: CHG=((2.0D0*A-B+Z)*CY1+(B-A)*CY0)/A Warning: 'IMAGPART_EXPR ' may be used uninitialized in this function [-Wmaybe-uninitialized] scipy/special/specfun/specfun.f:6160:0: Warning: 'REALPART_EXPR ' may be used uninitialized in this function [-Wmaybe-uninitialized] scipy/special/specfun/specfun.f:6115:0: IF (CDABS((CHG-CHW)/CHG).LT.1.D-15) GO TO 25 Warning: 'IMAGPART_EXPR ' may be used uninitialized in this function [-Wmaybe-uninitialized] scipy/special/specfun/specfun.f:6115:0: Warning: 'REALPART_EXPR ' may be used uninitialized in this function [-Wmaybe-uninitialized] scipy/special/specfun/specfun.f:6459:0: IF (K.GT.150) ISFER=5 Warning: 'k' may be used uninitialized in this function [-Wmaybe-uninitialized] scipy/special/specfun/specfun.f:6393:0: IF (CDABS((ZHF-ZW)/ZHF).LE.EPS) GO TO 115 Warning: 'IMAGPART_EXPR ' may be used uninitialized in this function [-Wmaybe-uninitialized] scipy/special/specfun/specfun.f:6393:0: Warning: 'REALPART_EXPR ' may be used uninitialized in this function [-Wmaybe-uninitialized] scipy/special/specfun/specfun.f:6768:0: CBY(LB+1)=(CBJ(LB+1)*CBY0-2.0D0*CP11/(PI*Z))/CBJ(0) Warning: 'IMAGPART_EXPR ' may be used uninitialized in this function [-Wmaybe-uninitialized] scipy/special/specfun/specfun.f:6768:0: Warning: 'REALPART_EXPR ' may be used uninitialized in this function [-Wmaybe-uninitialized] scipy/special/specfun/specfun.f:6718:0: CF=2.0D0*(K+1.0D0)/Z*CF1-CF2 Warning: 'IMAGPART_EXPR ' may be used uninitialized in this function [-Wmaybe-uninitialized] scipy/special/specfun/specfun.f:6718:0: Warning: 'REALPART_EXPR ' may be used uninitialized in this function [-Wmaybe-uninitialized] scipy/special/specfun/specfun.f:10318:0: CF=(2.0D0*K+3.0D0)*CF1/Z+CF0 Warning: 'IMAGPART_EXPR ' may be used uninitialized in this function [-Wmaybe-uninitialized] scipy/special/specfun/specfun.f:10318:0: Warning: 'REALPART_EXPR ' may be used uninitialized in this function [-Wmaybe-uninitialized] scipy/special/specfun/specfun.f:11358:0: CF=2.0D0*(V0+K+1.0D0)/Z1*CF1+CF2 Warning: 'IMAGPART_EXPR ' may be used uninitialized in this function [-Wmaybe-uninitialized] scipy/special/specfun/specfun.f:11358:0: Warning: 'REALPART_EXPR ' may be used uninitialized in this function [-Wmaybe-uninitialized] scipy/special/specfun/specfun.f:11519:0: CF=2.0D0*(V0+K+1.0D0)/Z1*CF1+CF2 Warning: 'IMAGPART_EXPR ' may be used uninitialized in this function [-Wmaybe-uninitialized] scipy/special/specfun/specfun.f:11519:0: Warning: 'REALPART_EXPR ' may be used uninitialized in this function [-Wmaybe-uninitialized] scipy/special/specfun/specfun.f:12147:0: IF (L.EQ.0) F0=F1 Warning: 'f1' may be used uninitialized in this function [-Wmaybe-uninitialized] scipy/special/specfun/specfun.f:12283:0: CQF0=((2*K+3.0D0)*Z*CQF1-(K+2.0D0)*CQF2)/(K+1.0D0) Warning: 'IMAGPART_EXPR ' may be used uninitialized in this function [-Wmaybe-uninitialized] scipy/special/specfun/specfun.f:12283:0: Warning: 'REALPART_EXPR ' may be used uninitialized in this function [-Wmaybe-uninitialized] scipy/special/specfun/specfun.f:12584:0: CF=2.0D0*(K+1.0D0)/Z*CF1+CF2 Warning: 'IMAGPART_EXPR ' may be used uninitialized in this function [-Wmaybe-uninitialized] scipy/special/specfun/specfun.f:12584:0: Warning: 'REALPART_EXPR ' may be used uninitialized in this function [-Wmaybe-uninitialized] ar: adding 1 object files to build/temp.linux-ppc64le-2.7/libsc_specfun.a building 'statlib' library compiling Fortran sources Fortran f77 compiler: /usr/bin/gfortran -Wall -g -ffixed-form -fno-second-underscore -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -fPIC -cpp -O3 -funroll-loops Fortran f90 compiler: /usr/bin/gfortran -Wall -g -fno-second-underscore -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -fPIC -cpp -O3 -funroll-loops Fortran fix compiler: /usr/bin/gfortran -Wall -g -ffixed-form -fno-second-underscore -Wall -g -fno-second-underscore -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -fPIC -cpp -O3 -funroll-loops creating build/temp.linux-ppc64le-2.7/scipy/stats creating build/temp.linux-ppc64le-2.7/scipy/stats/statlib compile options: '-I/usr/lib64/python2.7/site-packages/numpy/core/include -c' gfortran:f77: scipy/stats/statlib/spearman.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran scipy/stats/statlib/spearman.f:12:49: double precision zero, one, two, b, x, y, z, u, six, 1 Warning: Unused variable 'z' declared at (1) [-Wunused-variable] gfortran:f77: scipy/stats/statlib/swilk.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/stats/statlib/ansari.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran ar: adding 3 object files to build/temp.linux-ppc64le-2.7/libstatlib.a running build_ext customize UnixCCompiler customize UnixCCompiler using build_ext resetting extension 'scipy.integrate._quadpack' language from 'c' to 'f77'. resetting extension 'scipy.integrate._odepack' language from 'c' to 'f77'. resetting extension 'scipy.integrate.vode' language from 'c' to 'f77'. resetting extension 'scipy.integrate.lsoda' language from 'c' to 'f77'. resetting extension 'scipy.integrate._test_odeint_banded' language from 'c' to 'f77'. resetting extension 'scipy.linalg._fblas' language from 'c' to 'f77'. resetting extension 'scipy.linalg._flapack' language from 'c' to 'f77'. resetting extension 'scipy.linalg._flinalg' language from 'c' to 'f77'. resetting extension 'scipy.linalg._interpolative' language from 'c' to 'f77'. resetting extension 'scipy.linalg.cython_blas' language from 'c' to 'f77'. resetting extension 'scipy.linalg.cython_lapack' language from 'c' to 'f77'. resetting extension 'scipy.odr.__odrpack' language from 'c' to 'f77'. resetting extension 'scipy.optimize._lbfgsb' language from 'c' to 'f77'. resetting extension 'scipy.sparse.linalg.isolve._iterative' language from 'c' to 'f77'. extending extension 'scipy.sparse.linalg.dsolve._superlu' defined_macros with [('USE_VENDOR_BLAS', 1)] resetting extension 'scipy.sparse.linalg.eigen.arpack._arpack' language from 'c' to 'f77'. resetting extension 'scipy.special._ufuncs' language from 'c' to 'f77'. resetting extension 'scipy.special.cython_special' language from 'c' to 'f77'. customize UnixCCompiler customize UnixCCompiler using build_ext customize Gnu95FCompiler customize Gnu95FCompiler using build_ext building 'scipy.cluster._vq' extension compiling C sources C compiler: gcc -pthread -fno-strict-aliasing -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -D_GNU_SOURCE -fPIC -fwrapv -DNDEBUG -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -D_GNU_SOURCE -fPIC -fwrapv -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -fPIC creating build/temp.linux-ppc64le-2.7/scipy/cluster compile options: '-DHAVE_CBLAS -I/usr/lib64/python2.7/site-packages/numpy/core/include -I/usr/lib64/python2.7/site-packages/numpy/core/include -I/usr/include/python2.7 -c' gcc: scipy/cluster/_vq.c In file included from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/ndarraytypes.h:1816, from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/ndarrayobject.h:18, from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/arrayobject.h:4, from scipy/cluster/_vq.c:435: /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/npy_1_7_deprecated_api.h:15:2: warning: #warning "Using deprecated NumPy API, disable it by " "#defining NPY_NO_DEPRECATED_API NPY_1_7_API_VERSION" [-Wcpp] #warning "Using deprecated NumPy API, disable it by " \ ^~~~~~~ In file included from scipy/cluster/_vq.c:437: scipy/cluster/_vq.c: In function '__pyx_fuse_0__pyx_f_5scipy_7cluster_3_vq_cal_M': scipy/cluster/cluster_blas.h:19:24: warning: implicit declaration of function 'sgemm_'; did you mean 'gamma'? [-Wimplicit-function-declaration] #define f_sgemm F_FUNC(sgemm,SGEMM) ^~~~~ scipy/cluster/cluster_blas.h:15:21: note: in definition of macro 'F_FUNC' #define F_FUNC(f,F) f##_ ^ scipy/cluster/_vq.c:1758:3: note: in expansion of macro 'f_sgemm' f_sgemm(((char *)"T"), ((char *)"N"), (&__pyx_v_ncodes), (&__pyx_v_nobs), (&__pyx_v_nfeat), (&__pyx_v_alpha), __pyx_v_code_book, (&__pyx_v_nfeat), __pyx_v_obs, (&__pyx_v_nfeat), (&__pyx_v_beta), __pyx_v_M, (&__pyx_v_ncodes)); ^~~~~~~ scipy/cluster/_vq.c: In function '__pyx_fuse_1__pyx_f_5scipy_7cluster_3_vq_cal_M': scipy/cluster/cluster_blas.h:20:24: warning: implicit declaration of function 'dgemm_'; did you mean 'dreml'? [-Wimplicit-function-declaration] #define f_dgemm F_FUNC(dgemm,DGEMM) ^~~~~ scipy/cluster/cluster_blas.h:15:21: note: in definition of macro 'F_FUNC' #define F_FUNC(f,F) f##_ ^ scipy/cluster/_vq.c:1795:3: note: in expansion of macro 'f_dgemm' f_dgemm(((char *)"T"), ((char *)"N"), (&__pyx_v_ncodes), (&__pyx_v_nobs), (&__pyx_v_nfeat), (&__pyx_v_alpha), __pyx_v_code_book, (&__pyx_v_nfeat), __pyx_v_obs, (&__pyx_v_nfeat), (&__pyx_v_beta), __pyx_v_M, (&__pyx_v_ncodes)); ^~~~~~~ gcc -pthread -shared -Wl,-z,relro -Wl,-z,now -specs=/usr/lib/rpm/redhat/redhat-hardened-ld -Wl,-z,relro -Wl,-z,now -specs=/usr/lib/rpm/redhat/redhat-hardened-ld -shared -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection build/temp.linux-ppc64le-2.7/scipy/cluster/_vq.o -L/usr/lib64 -L/usr/lib64 -Lbuild/temp.linux-ppc64le-2.7 -lopenblasp -lopenblas -lpython2.7 -o build/lib.linux-ppc64le-2.7/scipy/cluster/_vq.so building 'scipy.cluster._hierarchy' extension compiling C sources C compiler: gcc -pthread -fno-strict-aliasing -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -D_GNU_SOURCE -fPIC -fwrapv -DNDEBUG -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -D_GNU_SOURCE -fPIC -fwrapv -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -fPIC compile options: '-I/usr/lib64/python2.7/site-packages/numpy/core/include -I/usr/lib64/python2.7/site-packages/numpy/core/include -I/usr/include/python2.7 -c' gcc: scipy/cluster/_hierarchy.c In file included from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/ndarraytypes.h:1816, from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/ndarrayobject.h:18, from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/arrayobject.h:4, from scipy/cluster/_hierarchy.c:435: /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/npy_1_7_deprecated_api.h:15:2: warning: #warning "Using deprecated NumPy API, disable it by " "#defining NPY_NO_DEPRECATED_API NPY_1_7_API_VERSION" [-Wcpp] #warning "Using deprecated NumPy API, disable it by " \ ^~~~~~~ scipy/cluster/_hierarchy.c:17599:18: warning: '__Pyx_CFunc_double____double____double____double____int____int____int___to_py' defined but not used [-Wunused-function] static PyObject *__Pyx_CFunc_double____double____double____double____int____int____int___to_py(double (*__pyx_v_f)(double, double, double, int, int, int)) { ^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ scipy/cluster/_hierarchy.c: In function '__pyx_pw_5scipy_7cluster_10_hierarchy_29mst_single_linkage': scipy/cluster/_hierarchy.c:13698:142: warning: '__pyx_v_y' may be used uninitialized in this function [-Wmaybe-uninitialized] *((double *) ( /* dim=1 */ (( /* dim=0 */ (__pyx_v_Z.data + __pyx_t_23 * __pyx_v_Z.strides[0]) ) + __pyx_t_24 * __pyx_v_Z.strides[1]) )) = __pyx_v_y; ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~ scipy/cluster/_hierarchy.c:13271:7: note: '__pyx_v_y' was declared here int __pyx_v_y; ^~~~~~~~~ scipy/cluster/_hierarchy.c: In function '__pyx_pw_5scipy_7cluster_10_hierarchy_27nn_chain': scipy/cluster/_hierarchy.c:12897:8: warning: '__pyx_v_y' may be used uninitialized in this function [-Wmaybe-uninitialized] if (__pyx_t_11) { ^ scipy/cluster/_hierarchy.c:12325:7: note: '__pyx_v_y' was declared here int __pyx_v_y; ^~~~~~~~~ scipy/cluster/_hierarchy.c: In function '__pyx_pw_5scipy_7cluster_10_hierarchy_23linkage': scipy/cluster/_hierarchy.c:10632:16: warning: '__pyx_v_y' may be used uninitialized in this function [-Wmaybe-uninitialized] __pyx_t_21 = __pyx_v_y; ~~~~~~~~~~~^~~~~~~~~~~ scipy/cluster/_hierarchy.c:10233:7: note: '__pyx_v_y' was declared here int __pyx_v_y; ^~~~~~~~~ scipy/cluster/_hierarchy.c:10622:16: warning: '__pyx_v_x' may be used uninitialized in this function [-Wmaybe-uninitialized] __pyx_t_20 = __pyx_v_x; ~~~~~~~~~~~^~~~~~~~~~~ scipy/cluster/_hierarchy.c:10232:7: note: '__pyx_v_x' was declared here int __pyx_v_x; ^~~~~~~~~ scipy/cluster/_hierarchy.c: In function '__pyx_pw_5scipy_7cluster_10_hierarchy_25fast_linkage': scipy/cluster/_hierarchy.c:11940:92: warning: '__pyx_v_dist' may be used uninitialized in this function [-Wmaybe-uninitialized] *((double *) ( /* dim=0 */ (__pyx_v_D.data + __pyx_t_42 * __pyx_v_D.strides[0]) )) = __pyx_v_new_dist((*((double *) ( /* dim=0 */ (__pyx_v_D.data + __pyx_t_40 * __pyx_v_D.strides[0]) ))), (*((double *) ( /* dim=0 */ (__pyx_v_D.data + __pyx_t_41 * __pyx_v_D.strides[0]) ))), __pyx_v_dist, __pyx_v_nx, __pyx_v_ny, __pyx_v_nz); ^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ scipy/cluster/_hierarchy.c:11172:10: note: '__pyx_v_dist' was declared here double __pyx_v_dist; ^~~~~~~~~~~~ scipy/cluster/_hierarchy.c:11165:7: warning: '__pyx_v_y' may be used uninitialized in this function [-Wmaybe-uninitialized] int __pyx_v_y; ^~~~~~~~~ scipy/cluster/_hierarchy.c:11164:7: warning: '__pyx_v_x' may be used uninitialized in this function [-Wmaybe-uninitialized] int __pyx_v_x; ^~~~~~~~~ gcc -pthread -shared -Wl,-z,relro -Wl,-z,now -specs=/usr/lib/rpm/redhat/redhat-hardened-ld -Wl,-z,relro -Wl,-z,now -specs=/usr/lib/rpm/redhat/redhat-hardened-ld -shared -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection build/temp.linux-ppc64le-2.7/scipy/cluster/_hierarchy.o -L/usr/lib64 -Lbuild/temp.linux-ppc64le-2.7 -lpython2.7 -o build/lib.linux-ppc64le-2.7/scipy/cluster/_hierarchy.so building 'scipy.cluster._optimal_leaf_ordering' extension compiling C sources C compiler: gcc -pthread -fno-strict-aliasing -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -D_GNU_SOURCE -fPIC -fwrapv -DNDEBUG -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -D_GNU_SOURCE -fPIC -fwrapv -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -fPIC compile options: '-I/usr/lib64/python2.7/site-packages/numpy/core/include -I/usr/lib64/python2.7/site-packages/numpy/core/include -I/usr/include/python2.7 -c' gcc: scipy/cluster/_optimal_leaf_ordering.c In file included from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/ndarraytypes.h:1816, from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/ndarrayobject.h:18, from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/arrayobject.h:4, from scipy/cluster/_optimal_leaf_ordering.c:435: /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/npy_1_7_deprecated_api.h:15:2: warning: #warning "Using deprecated NumPy API, disable it by " "#defining NPY_NO_DEPRECATED_API NPY_1_7_API_VERSION" [-Wcpp] #warning "Using deprecated NumPy API, disable it by " \ ^~~~~~~ scipy/cluster/_optimal_leaf_ordering.c: In function '__pyx_pf_5scipy_7cluster_22_optimal_leaf_ordering_optimal_leaf_ordering.isra.45': scipy/cluster/_optimal_leaf_ordering.c:4335:19: warning: '__pyx_v_best_w' may be used uninitialized in this function [-Wmaybe-uninitialized] __pyx_t_109 = __pyx_v_best_w; ~~~~~~~~~~~~^~~~~~~~~~~~~~~~ scipy/cluster/_optimal_leaf_ordering.c:3007:7: note: '__pyx_v_best_w' was declared here int __pyx_v_best_w; ^~~~~~~~~~~~~~ scipy/cluster/_optimal_leaf_ordering.c:4334:19: warning: '__pyx_v_best_u' may be used uninitialized in this function [-Wmaybe-uninitialized] __pyx_t_108 = __pyx_v_best_u; ~~~~~~~~~~~~^~~~~~~~~~~~~~~~ scipy/cluster/_optimal_leaf_ordering.c:3006:7: note: '__pyx_v_best_u' was declared here int __pyx_v_best_u; ^~~~~~~~~~~~~~ gcc -pthread -shared -Wl,-z,relro -Wl,-z,now -specs=/usr/lib/rpm/redhat/redhat-hardened-ld -Wl,-z,relro -Wl,-z,now -specs=/usr/lib/rpm/redhat/redhat-hardened-ld -shared -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection build/temp.linux-ppc64le-2.7/scipy/cluster/_optimal_leaf_ordering.o -L/usr/lib64 -Lbuild/temp.linux-ppc64le-2.7 -lpython2.7 -o build/lib.linux-ppc64le-2.7/scipy/cluster/_optimal_leaf_ordering.so building 'scipy.fftpack._fftpack' extension compiling C sources C compiler: gcc -pthread -fno-strict-aliasing -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -D_GNU_SOURCE -fPIC -fwrapv -DNDEBUG -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -D_GNU_SOURCE -fPIC -fwrapv -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -fPIC creating build/temp.linux-ppc64le-2.7/build creating build/temp.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7 creating build/temp.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy creating build/temp.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/fftpack creating build/temp.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/fftpack/src creating build/temp.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/build creating build/temp.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7 creating build/temp.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy creating build/temp.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/fftpack compile options: '-Iscipy/fftpack/src -Ibuild/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/fftpack -I/usr/lib64/python2.7/site-packages/numpy/core/include -I/usr/include/python2.7 -c' gcc: scipy/fftpack/src/zfftnd.c gcc: scipy/fftpack/src/drfft.c gcc: scipy/fftpack/src/zfft.c gcc: build/src.linux-ppc64le-2.7/scipy/fftpack/src/dct.c gcc: build/src.linux-ppc64le-2.7/scipy/fftpack/_fftpackmodule.c In file included from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/ndarraytypes.h:1816, from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/ndarrayobject.h:18, from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/arrayobject.h:4, from build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/fftpack/fortranobject.h:13, from build/src.linux-ppc64le-2.7/scipy/fftpack/_fftpackmodule.c:16: /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/npy_1_7_deprecated_api.h:15:2: warning: #warning "Using deprecated NumPy API, disable it by " "#defining NPY_NO_DEPRECATED_API NPY_1_7_API_VERSION" [-Wcpp] #warning "Using deprecated NumPy API, disable it by " \ ^~~~~~~ gcc: build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/fftpack/fortranobject.c In file included from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/ndarraytypes.h:1816, from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/ndarrayobject.h:18, from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/arrayobject.h:4, from build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/fftpack/fortranobject.h:13, from build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/fftpack/fortranobject.c:2: /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/npy_1_7_deprecated_api.h:15:2: warning: #warning "Using deprecated NumPy API, disable it by " "#defining NPY_NO_DEPRECATED_API NPY_1_7_API_VERSION" [-Wcpp] #warning "Using deprecated NumPy API, disable it by " \ ^~~~~~~ gcc: build/src.linux-ppc64le-2.7/scipy/fftpack/src/dst.c gcc: scipy/fftpack/src/zrfft.c /usr/bin/gfortran -Wall -g -Wl,-z,relro -Wl,-z,now -specs=/usr/lib/rpm/redhat/redhat-hardened-ld -shared build/temp.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/fftpack/_fftpackmodule.o build/temp.linux-ppc64le-2.7/scipy/fftpack/src/zfft.o build/temp.linux-ppc64le-2.7/scipy/fftpack/src/drfft.o build/temp.linux-ppc64le-2.7/scipy/fftpack/src/zrfft.o build/temp.linux-ppc64le-2.7/scipy/fftpack/src/zfftnd.o build/temp.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/fftpack/src/dct.o build/temp.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/fftpack/src/dst.o build/temp.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/fftpack/fortranobject.o -L/usr/lib/gcc/ppc64le-redhat-linux/8 -L/usr/lib/gcc/ppc64le-redhat-linux/8 -L/usr/lib64 -Lbuild/temp.linux-ppc64le-2.7 -ldfftpack -lfftpack -lpython2.7 -lgfortran -o build/lib.linux-ppc64le-2.7/scipy/fftpack/_fftpack.so building 'scipy.fftpack.convolve' extension compiling C sources C compiler: gcc -pthread -fno-strict-aliasing -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -D_GNU_SOURCE -fPIC -fwrapv -DNDEBUG -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -D_GNU_SOURCE -fPIC -fwrapv -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -fPIC compile options: '-Ibuild/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/fftpack -I/usr/lib64/python2.7/site-packages/numpy/core/include -I/usr/include/python2.7 -c' gcc: build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/fftpack/fortranobject.c In file included from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/ndarraytypes.h:1816, from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/ndarrayobject.h:18, from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/arrayobject.h:4, from build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/fftpack/fortranobject.h:13, from build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/fftpack/fortranobject.c:2: /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/npy_1_7_deprecated_api.h:15:2: warning: #warning "Using deprecated NumPy API, disable it by " "#defining NPY_NO_DEPRECATED_API NPY_1_7_API_VERSION" [-Wcpp] #warning "Using deprecated NumPy API, disable it by " \ ^~~~~~~ gcc: scipy/fftpack/src/convolve.c gcc: build/src.linux-ppc64le-2.7/scipy/fftpack/convolvemodule.c In file included from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/ndarraytypes.h:1816, from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/ndarrayobject.h:18, from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/arrayobject.h:4, from build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/fftpack/fortranobject.h:13, from build/src.linux-ppc64le-2.7/scipy/fftpack/convolvemodule.c:16: /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/npy_1_7_deprecated_api.h:15:2: warning: #warning "Using deprecated NumPy API, disable it by " "#defining NPY_NO_DEPRECATED_API NPY_1_7_API_VERSION" [-Wcpp] #warning "Using deprecated NumPy API, disable it by " \ ^~~~~~~ build/src.linux-ppc64le-2.7/scipy/fftpack/convolvemodule.c:128:12: warning: 'f2py_size' defined but not used [-Wunused-function] static int f2py_size(PyArrayObject* var, ...) ^~~~~~~~~ /usr/bin/gfortran -Wall -g -Wl,-z,relro -Wl,-z,now -specs=/usr/lib/rpm/redhat/redhat-hardened-ld -shared build/temp.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/fftpack/convolvemodule.o build/temp.linux-ppc64le-2.7/scipy/fftpack/src/convolve.o build/temp.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/fftpack/fortranobject.o -L/usr/lib/gcc/ppc64le-redhat-linux/8 -L/usr/lib/gcc/ppc64le-redhat-linux/8 -L/usr/lib64 -Lbuild/temp.linux-ppc64le-2.7 -ldfftpack -lpython2.7 -lgfortran -o build/lib.linux-ppc64le-2.7/scipy/fftpack/convolve.so building 'scipy.integrate._quadpack' extension compiling C sources C compiler: gcc -pthread -fno-strict-aliasing -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -D_GNU_SOURCE -fPIC -fwrapv -DNDEBUG -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -D_GNU_SOURCE -fPIC -fwrapv -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -fPIC compile options: '-DHAVE_CBLAS -Iscipy/_lib/src -I/usr/lib64/python2.7/site-packages/numpy/core/include -I/usr/include/python2.7 -c' gcc: scipy/integrate/_quadpackmodule.c In file included from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/ndarraytypes.h:1816, from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/ndarrayobject.h:18, from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/arrayobject.h:4, from scipy/integrate/__quadpack.h:28, from scipy/integrate/_quadpackmodule.c:4: /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/npy_1_7_deprecated_api.h:15:2: warning: #warning "Using deprecated NumPy API, disable it by " "#defining NPY_NO_DEPRECATED_API NPY_1_7_API_VERSION" [-Wcpp] #warning "Using deprecated NumPy API, disable it by " \ ^~~~~~~ In file included from scipy/integrate/_quadpackmodule.c:4: scipy/integrate/__quadpack.h: In function 'init_callback': scipy/integrate/__quadpack.h:163:9: warning: variable 'legacy' set but not used [-Wunused-but-set-variable] int legacy = 0; ^~~~~~ /usr/bin/gfortran -Wall -g -Wl,-z,relro -Wl,-z,now -specs=/usr/lib/rpm/redhat/redhat-hardened-ld -shared build/temp.linux-ppc64le-2.7/scipy/integrate/_quadpackmodule.o -L/usr/lib64 -L/usr/lib/gcc/ppc64le-redhat-linux/8 -L/usr/lib/gcc/ppc64le-redhat-linux/8 -L/usr/lib64 -Lbuild/temp.linux-ppc64le-2.7 -Wl,-rpath="/usr/lib64" -lquadpack -lmach -lopenblasp -lopenblas -lpython2.7 -lgfortran -o build/lib.linux-ppc64le-2.7/scipy/integrate/_quadpack.so building 'scipy.integrate._odepack' extension compiling C sources C compiler: gcc -pthread -fno-strict-aliasing -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -D_GNU_SOURCE -fPIC -fwrapv -DNDEBUG -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -D_GNU_SOURCE -fPIC -fwrapv -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -fPIC compile options: '-DNPY_NO_DEPRECATED_API=NPY_1_9_API_VERSION -I/usr/lib64/python2.7/site-packages/numpy/core/include -I/usr/include/python2.7 -c' gcc: scipy/integrate/_odepackmodule.c scipy/integrate/_odepackmodule.c: In function 'odepack_odeint': scipy/integrate/_odepackmodule.c:694:20: warning: 'tcrit' may be used uninitialized in this function [-Wmaybe-uninitialized] rwork[0] = *tcrit; ^~~~~~ /usr/bin/gfortran -Wall -g -Wl,-z,relro -Wl,-z,now -specs=/usr/lib/rpm/redhat/redhat-hardened-ld -shared build/temp.linux-ppc64le-2.7/scipy/integrate/_odepackmodule.o -L/usr/lib64 -L/usr/lib/gcc/ppc64le-redhat-linux/8 -L/usr/lib/gcc/ppc64le-redhat-linux/8 -L/usr/lib64 -Lbuild/temp.linux-ppc64le-2.7 -Wl,-rpath="/usr/lib64" -llsoda -lmach -lopenblasp -lopenblas -lpython2.7 -lgfortran -o build/lib.linux-ppc64le-2.7/scipy/integrate/_odepack.so building 'scipy.integrate.vode' extension compiling C sources C compiler: gcc -pthread -fno-strict-aliasing -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -D_GNU_SOURCE -fPIC -fwrapv -DNDEBUG -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -D_GNU_SOURCE -fPIC -fwrapv -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -fPIC creating build/temp.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/integrate creating build/temp.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/integrate compile options: '-DHAVE_CBLAS -Ibuild/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/integrate -I/usr/lib64/python2.7/site-packages/numpy/core/include -I/usr/include/python2.7 -c' gcc: build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/integrate/fortranobject.c In file included from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/ndarraytypes.h:1816, from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/ndarrayobject.h:18, from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/arrayobject.h:4, from build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/integrate/fortranobject.h:13, from build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/integrate/fortranobject.c:2: /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/npy_1_7_deprecated_api.h:15:2: warning: #warning "Using deprecated NumPy API, disable it by " "#defining NPY_NO_DEPRECATED_API NPY_1_7_API_VERSION" [-Wcpp] #warning "Using deprecated NumPy API, disable it by " \ ^~~~~~~ gcc: build/src.linux-ppc64le-2.7/scipy/integrate/vodemodule.c In file included from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/ndarraytypes.h:1816, from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/ndarrayobject.h:18, from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/arrayobject.h:4, from build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/integrate/fortranobject.h:13, from build/src.linux-ppc64le-2.7/scipy/integrate/vodemodule.c:16: /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/npy_1_7_deprecated_api.h:15:2: warning: #warning "Using deprecated NumPy API, disable it by " "#defining NPY_NO_DEPRECATED_API NPY_1_7_API_VERSION" [-Wcpp] #warning "Using deprecated NumPy API, disable it by " \ ^~~~~~~ build/src.linux-ppc64le-2.7/scipy/integrate/vodemodule.c: In function 'cb_f_in_dvode__user__routines': build/src.linux-ppc64le-2.7/scipy/integrate/vodemodule.c:371:7: warning: unused variable 'ipar' [-Wunused-variable] int ipar=(*ipar_cb_capi); ^~~~ build/src.linux-ppc64le-2.7/scipy/integrate/vodemodule.c:370:10: warning: unused variable 'rpar' [-Wunused-variable] double rpar=(*rpar_cb_capi); ^~~~ build/src.linux-ppc64le-2.7/scipy/integrate/vodemodule.c: In function 'cb_jac_in_dvode__user__routines': build/src.linux-ppc64le-2.7/scipy/integrate/vodemodule.c:525:7: warning: unused variable 'ipar' [-Wunused-variable] int ipar=(*ipar_cb_capi); ^~~~ build/src.linux-ppc64le-2.7/scipy/integrate/vodemodule.c:524:10: warning: unused variable 'rpar' [-Wunused-variable] double rpar=(*rpar_cb_capi); ^~~~ build/src.linux-ppc64le-2.7/scipy/integrate/vodemodule.c:522:7: warning: unused variable 'mu' [-Wunused-variable] int mu=(*mu_cb_capi); ^~ build/src.linux-ppc64le-2.7/scipy/integrate/vodemodule.c:521:7: warning: unused variable 'ml' [-Wunused-variable] int ml=(*ml_cb_capi); ^~ build/src.linux-ppc64le-2.7/scipy/integrate/vodemodule.c: In function 'cb_f_in_zvode__user__routines': build/src.linux-ppc64le-2.7/scipy/integrate/vodemodule.c:675:7: warning: unused variable 'ipar' [-Wunused-variable] int ipar=(*ipar_cb_capi); ^~~~ build/src.linux-ppc64le-2.7/scipy/integrate/vodemodule.c:674:10: warning: unused variable 'rpar' [-Wunused-variable] double rpar=(*rpar_cb_capi); ^~~~ build/src.linux-ppc64le-2.7/scipy/integrate/vodemodule.c: In function 'cb_jac_in_zvode__user__routines': build/src.linux-ppc64le-2.7/scipy/integrate/vodemodule.c:829:7: warning: unused variable 'ipar' [-Wunused-variable] int ipar=(*ipar_cb_capi); ^~~~ build/src.linux-ppc64le-2.7/scipy/integrate/vodemodule.c:828:10: warning: unused variable 'rpar' [-Wunused-variable] double rpar=(*rpar_cb_capi); ^~~~ build/src.linux-ppc64le-2.7/scipy/integrate/vodemodule.c:826:7: warning: unused variable 'mu' [-Wunused-variable] int mu=(*mu_cb_capi); ^~ build/src.linux-ppc64le-2.7/scipy/integrate/vodemodule.c:825:7: warning: unused variable 'ml' [-Wunused-variable] int ml=(*ml_cb_capi); ^~ build/src.linux-ppc64le-2.7/scipy/integrate/vodemodule.c: In function 'f2py_rout_vode_dvode': build/src.linux-ppc64le-2.7/scipy/integrate/vodemodule.c:1019:43: warning: variable 'jac_cptr' set but not used [-Wunused-but-set-variable] cb_jac_in_dvode__user__routines_typedef jac_cptr; ^~~~~~~~ build/src.linux-ppc64le-2.7/scipy/integrate/vodemodule.c:1014:41: warning: variable 'f_cptr' set but not used [-Wunused-but-set-variable] cb_f_in_dvode__user__routines_typedef f_cptr; ^~~~~~ build/src.linux-ppc64le-2.7/scipy/integrate/vodemodule.c: In function 'f2py_rout_vode_zvode': build/src.linux-ppc64le-2.7/scipy/integrate/vodemodule.c:1347:43: warning: variable 'jac_cptr' set but not used [-Wunused-but-set-variable] cb_jac_in_zvode__user__routines_typedef jac_cptr; ^~~~~~~~ build/src.linux-ppc64le-2.7/scipy/integrate/vodemodule.c:1342:41: warning: variable 'f_cptr' set but not used [-Wunused-but-set-variable] cb_f_in_zvode__user__routines_typedef f_cptr; ^~~~~~ At top level: build/src.linux-ppc64le-2.7/scipy/integrate/vodemodule.c:142:12: warning: 'f2py_size' defined but not used [-Wunused-function] static int f2py_size(PyArrayObject* var, ...) ^~~~~~~~~ /usr/bin/gfortran -Wall -g -Wl,-z,relro -Wl,-z,now -specs=/usr/lib/rpm/redhat/redhat-hardened-ld -shared build/temp.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/integrate/vodemodule.o build/temp.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/integrate/fortranobject.o -L/usr/lib64 -L/usr/lib/gcc/ppc64le-redhat-linux/8 -L/usr/lib/gcc/ppc64le-redhat-linux/8 -L/usr/lib64 -Lbuild/temp.linux-ppc64le-2.7 -Wl,-rpath="/usr/lib64" -lvode -lopenblasp -lopenblas -lpython2.7 -lgfortran -o build/lib.linux-ppc64le-2.7/scipy/integrate/vode.so building 'scipy.integrate.lsoda' extension compiling C sources C compiler: gcc -pthread -fno-strict-aliasing -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -D_GNU_SOURCE -fPIC -fwrapv -DNDEBUG -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -D_GNU_SOURCE -fPIC -fwrapv -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -fPIC compile options: '-DHAVE_CBLAS -Ibuild/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/integrate -I/usr/lib64/python2.7/site-packages/numpy/core/include -I/usr/include/python2.7 -c' gcc: build/src.linux-ppc64le-2.7/scipy/integrate/lsodamodule.c In file included from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/ndarraytypes.h:1816, from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/ndarrayobject.h:18, from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/arrayobject.h:4, from build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/integrate/fortranobject.h:13, from build/src.linux-ppc64le-2.7/scipy/integrate/lsodamodule.c:16: /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/npy_1_7_deprecated_api.h:15:2: warning: #warning "Using deprecated NumPy API, disable it by " "#defining NPY_NO_DEPRECATED_API NPY_1_7_API_VERSION" [-Wcpp] #warning "Using deprecated NumPy API, disable it by " \ ^~~~~~~ build/src.linux-ppc64le-2.7/scipy/integrate/lsodamodule.c: In function 'cb_jac_in_lsoda__user__routines': build/src.linux-ppc64le-2.7/scipy/integrate/lsodamodule.c:517:7: warning: unused variable 'mu' [-Wunused-variable] int mu=(*mu_cb_capi); ^~ build/src.linux-ppc64le-2.7/scipy/integrate/lsodamodule.c:516:7: warning: unused variable 'ml' [-Wunused-variable] int ml=(*ml_cb_capi); ^~ build/src.linux-ppc64le-2.7/scipy/integrate/lsodamodule.c: In function 'f2py_rout_lsoda_lsoda': build/src.linux-ppc64le-2.7/scipy/integrate/lsodamodule.c:752:43: warning: variable 'jac_cptr' set but not used [-Wunused-but-set-variable] cb_jac_in_lsoda__user__routines_typedef jac_cptr; ^~~~~~~~ build/src.linux-ppc64le-2.7/scipy/integrate/lsodamodule.c:703:41: warning: variable 'f_cptr' set but not used [-Wunused-but-set-variable] cb_f_in_lsoda__user__routines_typedef f_cptr; ^~~~~~ At top level: build/src.linux-ppc64le-2.7/scipy/integrate/lsodamodule.c:140:12: warning: 'f2py_size' defined but not used [-Wunused-function] static int f2py_size(PyArrayObject* var, ...) ^~~~~~~~~ /usr/bin/gfortran -Wall -g -Wl,-z,relro -Wl,-z,now -specs=/usr/lib/rpm/redhat/redhat-hardened-ld -shared build/temp.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/integrate/lsodamodule.o build/temp.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/integrate/fortranobject.o -L/usr/lib64 -L/usr/lib/gcc/ppc64le-redhat-linux/8 -L/usr/lib/gcc/ppc64le-redhat-linux/8 -L/usr/lib64 -Lbuild/temp.linux-ppc64le-2.7 -Wl,-rpath="/usr/lib64" -llsoda -lmach -lopenblasp -lopenblas -lpython2.7 -lgfortran -o build/lib.linux-ppc64le-2.7/scipy/integrate/lsoda.so building 'scipy.integrate._dop' extension compiling C sources C compiler: gcc -pthread -fno-strict-aliasing -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -D_GNU_SOURCE -fPIC -fwrapv -DNDEBUG -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -D_GNU_SOURCE -fPIC -fwrapv -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -fPIC compile options: '-Ibuild/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/integrate -I/usr/lib64/python2.7/site-packages/numpy/core/include -I/usr/include/python2.7 -c' gcc: build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/integrate/fortranobject.c In file included from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/ndarraytypes.h:1816, from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/ndarrayobject.h:18, from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/arrayobject.h:4, from build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/integrate/fortranobject.h:13, from build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/integrate/fortranobject.c:2: /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/npy_1_7_deprecated_api.h:15:2: warning: #warning "Using deprecated NumPy API, disable it by " "#defining NPY_NO_DEPRECATED_API NPY_1_7_API_VERSION" [-Wcpp] #warning "Using deprecated NumPy API, disable it by " \ ^~~~~~~ gcc: build/src.linux-ppc64le-2.7/scipy/integrate/_dopmodule.c In file included from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/ndarraytypes.h:1816, from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/ndarrayobject.h:18, from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/arrayobject.h:4, from build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/integrate/fortranobject.h:13, from build/src.linux-ppc64le-2.7/scipy/integrate/_dopmodule.c:16: /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/npy_1_7_deprecated_api.h:15:2: warning: #warning "Using deprecated NumPy API, disable it by " "#defining NPY_NO_DEPRECATED_API NPY_1_7_API_VERSION" [-Wcpp] #warning "Using deprecated NumPy API, disable it by " \ ^~~~~~~ build/src.linux-ppc64le-2.7/scipy/integrate/_dopmodule.c: In function 'cb_fcn_in___user__routines': build/src.linux-ppc64le-2.7/scipy/integrate/_dopmodule.c:369:7: warning: unused variable 'ipar' [-Wunused-variable] int ipar=(*ipar_cb_capi); ^~~~ build/src.linux-ppc64le-2.7/scipy/integrate/_dopmodule.c:368:10: warning: unused variable 'rpar' [-Wunused-variable] double rpar=(*rpar_cb_capi); ^~~~ build/src.linux-ppc64le-2.7/scipy/integrate/_dopmodule.c: In function 'cb_solout_in___user__routines': build/src.linux-ppc64le-2.7/scipy/integrate/_dopmodule.c:524:7: warning: unused variable 'irtn' [-Wunused-variable] int irtn=(*irtn_cb_capi); ^~~~ build/src.linux-ppc64le-2.7/scipy/integrate/_dopmodule.c:523:7: warning: unused variable 'ipar' [-Wunused-variable] int ipar=(*ipar_cb_capi); ^~~~ build/src.linux-ppc64le-2.7/scipy/integrate/_dopmodule.c:522:10: warning: unused variable 'rpar' [-Wunused-variable] double rpar=(*rpar_cb_capi); ^~~~ At top level: build/src.linux-ppc64le-2.7/scipy/integrate/_dopmodule.c:140:12: warning: 'f2py_size' defined but not used [-Wunused-function] static int f2py_size(PyArrayObject* var, ...) ^~~~~~~~~ /usr/bin/gfortran -Wall -g -Wl,-z,relro -Wl,-z,now -specs=/usr/lib/rpm/redhat/redhat-hardened-ld -shared build/temp.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/integrate/_dopmodule.o build/temp.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/integrate/fortranobject.o -L/usr/lib/gcc/ppc64le-redhat-linux/8 -L/usr/lib/gcc/ppc64le-redhat-linux/8 -L/usr/lib64 -Lbuild/temp.linux-ppc64le-2.7 -ldop -lpython2.7 -lgfortran -o build/lib.linux-ppc64le-2.7/scipy/integrate/_dop.so building 'scipy.integrate._test_multivariate' extension compiling C sources C compiler: gcc -pthread -fno-strict-aliasing -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -D_GNU_SOURCE -fPIC -fwrapv -DNDEBUG -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -D_GNU_SOURCE -fPIC -fwrapv -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -fPIC creating build/temp.linux-ppc64le-2.7/scipy/integrate/tests compile options: '-I/usr/lib64/python2.7/site-packages/numpy/core/include -I/usr/include/python2.7 -c' gcc: scipy/integrate/tests/_test_multivariate.c gcc -pthread -shared -Wl,-z,relro -Wl,-z,now -specs=/usr/lib/rpm/redhat/redhat-hardened-ld -Wl,-z,relro -Wl,-z,now -specs=/usr/lib/rpm/redhat/redhat-hardened-ld -shared -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection build/temp.linux-ppc64le-2.7/scipy/integrate/tests/_test_multivariate.o -L/usr/lib64 -Lbuild/temp.linux-ppc64le-2.7 -lpython2.7 -o build/lib.linux-ppc64le-2.7/scipy/integrate/_test_multivariate.so building 'scipy.integrate._test_odeint_banded' extension compiling C sources C compiler: gcc -pthread -fno-strict-aliasing -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -D_GNU_SOURCE -fPIC -fwrapv -DNDEBUG -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -D_GNU_SOURCE -fPIC -fwrapv -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -fPIC compile options: '-DHAVE_CBLAS -Ibuild/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/integrate -I/usr/lib64/python2.7/site-packages/numpy/core/include -I/usr/include/python2.7 -c' gcc: build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/integrate/fortranobject.c In file included from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/ndarraytypes.h:1816, from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/ndarrayobject.h:18, from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/arrayobject.h:4, from build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/integrate/fortranobject.h:13, from build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/integrate/fortranobject.c:2: /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/npy_1_7_deprecated_api.h:15:2: warning: #warning "Using deprecated NumPy API, disable it by " "#defining NPY_NO_DEPRECATED_API NPY_1_7_API_VERSION" [-Wcpp] #warning "Using deprecated NumPy API, disable it by " \ ^~~~~~~ gcc: build/src.linux-ppc64le-2.7/scipy/integrate/_test_odeint_bandedmodule.c In file included from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/ndarraytypes.h:1816, from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/ndarrayobject.h:18, from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/arrayobject.h:4, from build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/integrate/fortranobject.h:13, from build/src.linux-ppc64le-2.7/scipy/integrate/_test_odeint_bandedmodule.c:16: /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/npy_1_7_deprecated_api.h:15:2: warning: #warning "Using deprecated NumPy API, disable it by " "#defining NPY_NO_DEPRECATED_API NPY_1_7_API_VERSION" [-Wcpp] #warning "Using deprecated NumPy API, disable it by " \ ^~~~~~~ build/src.linux-ppc64le-2.7/scipy/integrate/_test_odeint_bandedmodule.c:109:12: warning: 'f2py_size' defined but not used [-Wunused-function] static int f2py_size(PyArrayObject* var, ...) ^~~~~~~~~ compiling Fortran sources Fortran f77 compiler: /usr/bin/gfortran -Wall -g -ffixed-form -fno-second-underscore -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -fPIC -cpp -O3 -funroll-loops Fortran f90 compiler: /usr/bin/gfortran -Wall -g -fno-second-underscore -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -fPIC -cpp -O3 -funroll-loops Fortran fix compiler: /usr/bin/gfortran -Wall -g -ffixed-form -fno-second-underscore -Wall -g -fno-second-underscore -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -fPIC -cpp -O3 -funroll-loops compile options: '-DHAVE_CBLAS -Ibuild/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/integrate -I/usr/lib64/python2.7/site-packages/numpy/core/include -I/usr/include/python2.7 -c' gfortran:f77: scipy/integrate/tests/banded5x5.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran scipy/integrate/tests/banded5x5.f:85:31: subroutine banded5x5(n, t, y, f) 1 Warning: Unused dummy argument 't' at (1) [-Wunused-dummy-argument] scipy/integrate/tests/banded5x5.f:112:42: subroutine banded5x5_jac(n, t, y, ml, mu, jac, nrowpd) 1 Warning: Unused dummy argument 'ml' at (1) [-Wunused-dummy-argument] scipy/integrate/tests/banded5x5.f:112:46: subroutine banded5x5_jac(n, t, y, ml, mu, jac, nrowpd) 1 Warning: Unused dummy argument 'mu' at (1) [-Wunused-dummy-argument] scipy/integrate/tests/banded5x5.f:112:35: subroutine banded5x5_jac(n, t, y, ml, mu, jac, nrowpd) 1 Warning: Unused dummy argument 't' at (1) [-Wunused-dummy-argument] scipy/integrate/tests/banded5x5.f:112:38: subroutine banded5x5_jac(n, t, y, ml, mu, jac, nrowpd) 1 Warning: Unused dummy argument 'y' at (1) [-Wunused-dummy-argument] scipy/integrate/tests/banded5x5.f:139:43: subroutine banded5x5_bjac(n, t, y, ml, mu, bjac, nrowpd) 1 Warning: Unused dummy argument 'ml' at (1) [-Wunused-dummy-argument] scipy/integrate/tests/banded5x5.f:139:47: subroutine banded5x5_bjac(n, t, y, ml, mu, bjac, nrowpd) 1 Warning: Unused dummy argument 'mu' at (1) [-Wunused-dummy-argument] scipy/integrate/tests/banded5x5.f:139:36: subroutine banded5x5_bjac(n, t, y, ml, mu, bjac, nrowpd) 1 Warning: Unused dummy argument 't' at (1) [-Wunused-dummy-argument] scipy/integrate/tests/banded5x5.f:139:39: subroutine banded5x5_bjac(n, t, y, ml, mu, bjac, nrowpd) 1 Warning: Unused dummy argument 'y' at (1) [-Wunused-dummy-argument] gfortran:f77: build/src.linux-ppc64le-2.7/scipy/integrate/_test_odeint_banded-f2pywrappers.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran /usr/bin/gfortran -Wall -g -Wl,-z,relro -Wl,-z,now -specs=/usr/lib/rpm/redhat/redhat-hardened-ld -shared build/temp.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/integrate/_test_odeint_bandedmodule.o build/temp.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/integrate/fortranobject.o build/temp.linux-ppc64le-2.7/scipy/integrate/tests/banded5x5.o build/temp.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/integrate/_test_odeint_banded-f2pywrappers.o -L/usr/lib64 -L/usr/lib/gcc/ppc64le-redhat-linux/8 -L/usr/lib/gcc/ppc64le-redhat-linux/8 -L/usr/lib64 -Lbuild/temp.linux-ppc64le-2.7 -Wl,-rpath="/usr/lib64" -llsoda -lmach -lopenblasp -lopenblas -lpython2.7 -lgfortran -o build/lib.linux-ppc64le-2.7/scipy/integrate/_test_odeint_banded.so building 'scipy.interpolate.interpnd' extension compiling C sources C compiler: gcc -pthread -fno-strict-aliasing -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -D_GNU_SOURCE -fPIC -fwrapv -DNDEBUG -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -D_GNU_SOURCE -fPIC -fwrapv -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -fPIC compile options: '-I/usr/lib64/python2.7/site-packages/numpy/core/include -I/usr/include/python2.7 -c' gcc: scipy/interpolate/interpnd.c In file included from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/ndarraytypes.h:1816, from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/ndarrayobject.h:18, from scipy/interpolate/interpnd.c:434: /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/npy_1_7_deprecated_api.h:15:2: warning: #warning "Using deprecated NumPy API, disable it by " "#defining NPY_NO_DEPRECATED_API NPY_1_7_API_VERSION" [-Wcpp] #warning "Using deprecated NumPy API, disable it by " \ ^~~~~~~ In file included from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/ndarrayobject.h:27, from scipy/interpolate/interpnd.c:434: /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/__multiarray_api.h:1463:1: warning: '_import_array' defined but not used [-Wunused-function] _import_array(void) ^~~~~~~~~~~~~ scipy/interpolate/interpnd.c: In function '__pyx_pf_5scipy_11interpolate_8interpnd_26CloughTocher2DInterpolator_8_do_evaluate.isra.44': scipy/interpolate/interpnd.c:9506:123: warning: '__pyx_v_g3' may be used uninitialized in this function [-Wmaybe-uninitialized] __pyx_v_c1101 = (((__pyx_v_g3 * ((((-__pyx_v_c3000) + (3.0 * __pyx_v_c2100)) - (3.0 * __pyx_v_c1200)) + __pyx_v_c0300)) + (((((-__pyx_v_c3000) + (2.0 * __pyx_v_c2100)) - __pyx_v_c1200) + __pyx_v_c2001) + __pyx_v_c0201)) / 2.0); ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ scipy/interpolate/interpnd.c:8913:10: note: '__pyx_v_g3' was declared here double __pyx_v_g3; ^~~~~~~~~~ scipy/interpolate/interpnd.c:9497:123: warning: '__pyx_v_g2' may be used uninitialized in this function [-Wmaybe-uninitialized] __pyx_v_c1011 = (((__pyx_v_g2 * ((((-__pyx_v_c0030) + (3.0 * __pyx_v_c1020)) - (3.0 * __pyx_v_c2010)) + __pyx_v_c3000)) + (((((-__pyx_v_c0030) + (2.0 * __pyx_v_c1020)) - __pyx_v_c2010) + __pyx_v_c2001) + __pyx_v_c0021)) / 2.0); ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ scipy/interpolate/interpnd.c:8912:10: note: '__pyx_v_g2' was declared here double __pyx_v_g2; ^~~~~~~~~~ scipy/interpolate/interpnd.c: In function '__pyx_pf_5scipy_11interpolate_8interpnd_26CloughTocher2DInterpolator_10_do_evaluate.isra.43': scipy/interpolate/interpnd.c:30275:34: warning: '__pyx_v_g3' may be used uninitialized in this function [-Wmaybe-uninitialized] z.imag = a.real * b.imag + a.imag * b.real; ~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~ scipy/interpolate/interpnd.c:9691:10: note: '__pyx_v_g3' was declared here double __pyx_v_g3; ^~~~~~~~~~ scipy/interpolate/interpnd.c:30275:34: warning: '__pyx_v_g2' may be used uninitialized in this function [-Wmaybe-uninitialized] z.imag = a.real * b.imag + a.imag * b.real; ~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~ scipy/interpolate/interpnd.c:9690:10: note: '__pyx_v_g2' was declared here double __pyx_v_g2; ^~~~~~~~~~ gcc -pthread -shared -Wl,-z,relro -Wl,-z,now -specs=/usr/lib/rpm/redhat/redhat-hardened-ld -Wl,-z,relro -Wl,-z,now -specs=/usr/lib/rpm/redhat/redhat-hardened-ld -shared -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection build/temp.linux-ppc64le-2.7/scipy/interpolate/interpnd.o -L/usr/lib64 -Lbuild/temp.linux-ppc64le-2.7 -lpython2.7 -o build/lib.linux-ppc64le-2.7/scipy/interpolate/interpnd.so building 'scipy.interpolate._ppoly' extension compiling C sources C compiler: gcc -pthread -fno-strict-aliasing -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -D_GNU_SOURCE -fPIC -fwrapv -DNDEBUG -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -D_GNU_SOURCE -fPIC -fwrapv -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -fPIC compile options: '-DHAVE_CBLAS -I/usr/lib64/python2.7/site-packages/numpy/core/include -I/usr/include/python2.7 -c' gcc: scipy/interpolate/_ppoly.c In file included from scipy/interpolate/_ppoly.c:435: scipy/interpolate/_ppoly.c: In function '__pyx_f_5scipy_11interpolate_6_ppoly_croots_poly1': scipy/interpolate/blas_defs.h:19:24: warning: implicit declaration of function 'dgeev_'; did you mean 'c_dgeev'? [-Wimplicit-function-declaration] #define c_dgeev F_FUNC(dgeev,DGEEV) ^~~~~ scipy/interpolate/blas_defs.h:15:21: note: in definition of macro 'F_FUNC' #define F_FUNC(f,F) f##_ ^ scipy/interpolate/_ppoly.c:13575:3: note: in expansion of macro 'c_dgeev' c_dgeev(((char *)"N"), ((char *)"N"), (&__pyx_v_order), __pyx_v_a, (&__pyx_v_order), ((double *)__pyx_v_wr), ((double *)__pyx_v_wi), NULL, (&__pyx_v_order), NULL, (&__pyx_v_order), __pyx_v_work, (&__pyx_v_lwork), (&__pyx_v_info)); ^~~~~~~ gcc -pthread -shared -Wl,-z,relro -Wl,-z,now -specs=/usr/lib/rpm/redhat/redhat-hardened-ld -Wl,-z,relro -Wl,-z,now -specs=/usr/lib/rpm/redhat/redhat-hardened-ld -shared -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection build/temp.linux-ppc64le-2.7/scipy/interpolate/_ppoly.o -L/usr/lib64 -L/usr/lib64 -Lbuild/temp.linux-ppc64le-2.7 -lopenblasp -lopenblas -lpython2.7 -o build/lib.linux-ppc64le-2.7/scipy/interpolate/_ppoly.so building 'scipy.interpolate._bspl' extension compiling C sources C compiler: gcc -pthread -fno-strict-aliasing -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -D_GNU_SOURCE -fPIC -fwrapv -DNDEBUG -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -D_GNU_SOURCE -fPIC -fwrapv -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -fPIC compile options: '-I/usr/lib64/python2.7/site-packages/numpy/core/include -I/usr/include/python2.7 -c' gcc: scipy/interpolate/_bspl.c In file included from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/ndarraytypes.h:1816, from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/ndarrayobject.h:18, from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/arrayobject.h:4, from scipy/interpolate/_bspl.c:435: /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/npy_1_7_deprecated_api.h:15:2: warning: #warning "Using deprecated NumPy API, disable it by " "#defining NPY_NO_DEPRECATED_API NPY_1_7_API_VERSION" [-Wcpp] #warning "Using deprecated NumPy API, disable it by " \ ^~~~~~~ /usr/bin/gfortran -Wall -g -Wl,-z,relro -Wl,-z,now -specs=/usr/lib/rpm/redhat/redhat-hardened-ld -shared build/temp.linux-ppc64le-2.7/scipy/interpolate/_bspl.o -L/usr/lib/gcc/ppc64le-redhat-linux/8 -L/usr/lib/gcc/ppc64le-redhat-linux/8 -L/usr/lib64 -Lbuild/temp.linux-ppc64le-2.7 -lfitpack -lpython2.7 -lgfortran -o build/lib.linux-ppc64le-2.7/scipy/interpolate/_bspl.so building 'scipy.interpolate._fitpack' extension compiling C sources C compiler: gcc -pthread -fno-strict-aliasing -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -D_GNU_SOURCE -fPIC -fwrapv -DNDEBUG -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -D_GNU_SOURCE -fPIC -fwrapv -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -fPIC creating build/temp.linux-ppc64le-2.7/scipy/interpolate/src compile options: '-I/usr/lib64/python2.7/site-packages/numpy/core/include -I/usr/include/python2.7 -c' gcc: scipy/interpolate/src/_fitpackmodule.c In file included from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/ndarraytypes.h:1816, from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/ndarrayobject.h:18, from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/arrayobject.h:4, from scipy/interpolate/src/multipack.h:32, from scipy/interpolate/src/_fitpackmodule.c:5: /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/npy_1_7_deprecated_api.h:15:2: warning: #warning "Using deprecated NumPy API, disable it by " "#defining NPY_NO_DEPRECATED_API NPY_1_7_API_VERSION" [-Wcpp] #warning "Using deprecated NumPy API, disable it by " \ ^~~~~~~ In file included from scipy/interpolate/src/_fitpackmodule.c:5: scipy/interpolate/src/multipack.h: In function 'call_python_function': scipy/interpolate/src/multipack.h:143:27: warning: unused variable 'str1' [-Wunused-variable] PyObject *arg1 = NULL, *str1 = NULL; ^~~~ At top level: scipy/interpolate/src/multipack.h:124:18: warning: 'call_python_function' defined but not used [-Wunused-function] static PyObject *call_python_function(PyObject *func, npy_intp n, double *x, ^~~~~~~~~~~~~~~~~~~~ scipy/interpolate/src/_fitpackmodule.c: In function '_bspldismat': scipy/interpolate/src/_fitpackmodule.c:1354:22: warning: 'dx' may be used uninitialized in this function [-Wmaybe-uninitialized] factor = pow(dx, (double)k); ^~~~~~~~~~~~~~~~~~ /usr/bin/gfortran -Wall -g -Wl,-z,relro -Wl,-z,now -specs=/usr/lib/rpm/redhat/redhat-hardened-ld -shared build/temp.linux-ppc64le-2.7/scipy/interpolate/src/_fitpackmodule.o -L/usr/lib/gcc/ppc64le-redhat-linux/8 -L/usr/lib/gcc/ppc64le-redhat-linux/8 -L/usr/lib64 -Lbuild/temp.linux-ppc64le-2.7 -lfitpack -lpython2.7 -lgfortran -o build/lib.linux-ppc64le-2.7/scipy/interpolate/_fitpack.so building 'scipy.interpolate.dfitpack' extension compiling C sources C compiler: gcc -pthread -fno-strict-aliasing -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -D_GNU_SOURCE -fPIC -fwrapv -DNDEBUG -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -D_GNU_SOURCE -fPIC -fwrapv -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -fPIC creating build/temp.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/interpolate creating build/temp.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/interpolate/src creating build/temp.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/interpolate creating build/temp.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/interpolate/src compile options: '-Ibuild/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/interpolate/src -I/usr/lib64/python2.7/site-packages/numpy/core/include -I/usr/include/python2.7 -c' gcc: build/src.linux-ppc64le-2.7/scipy/interpolate/src/dfitpackmodule.c In file included from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/ndarraytypes.h:1816, from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/ndarrayobject.h:18, from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/arrayobject.h:4, from build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/interpolate/src/fortranobject.h:13, from build/src.linux-ppc64le-2.7/scipy/interpolate/src/dfitpackmodule.c:16: /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/npy_1_7_deprecated_api.h:15:2: warning: #warning "Using deprecated NumPy API, disable it by " "#defining NPY_NO_DEPRECATED_API NPY_1_7_API_VERSION" [-Wcpp] #warning "Using deprecated NumPy API, disable it by " \ ^~~~~~~ build/src.linux-ppc64le-2.7/scipy/interpolate/src/dfitpackmodule.c: In function 'initdfitpack': build/src.linux-ppc64le-2.7/scipy/interpolate/src/dfitpackmodule.c:6862:3: warning: this 'for' clause does not guard... [-Wmisleading-indentation] for(i=0;f2py_routine_defs[i].name!=NULL;i++) ^~~ build/src.linux-ppc64le-2.7/scipy/interpolate/src/dfitpackmodule.c:6868:5: note: ...this statement, but the latter is misleadingly indented as if it were guarded by the 'for' { ^ At top level: build/src.linux-ppc64le-2.7/scipy/interpolate/src/dfitpackmodule.c:149:12: warning: 'f2py_size' defined but not used [-Wunused-function] static int f2py_size(PyArrayObject* var, ...) ^~~~~~~~~ gcc: build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/interpolate/src/fortranobject.c In file included from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/ndarraytypes.h:1816, from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/ndarrayobject.h:18, from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/arrayobject.h:4, from build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/interpolate/src/fortranobject.h:13, from build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/interpolate/src/fortranobject.c:2: /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/npy_1_7_deprecated_api.h:15:2: warning: #warning "Using deprecated NumPy API, disable it by " "#defining NPY_NO_DEPRECATED_API NPY_1_7_API_VERSION" [-Wcpp] #warning "Using deprecated NumPy API, disable it by " \ ^~~~~~~ compiling Fortran sources Fortran f77 compiler: /usr/bin/gfortran -Wall -g -ffixed-form -fno-second-underscore -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -fPIC -cpp -O3 -funroll-loops Fortran f90 compiler: /usr/bin/gfortran -Wall -g -fno-second-underscore -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -fPIC -cpp -O3 -funroll-loops Fortran fix compiler: /usr/bin/gfortran -Wall -g -ffixed-form -fno-second-underscore -Wall -g -fno-second-underscore -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -fPIC -cpp -O3 -funroll-loops compile options: '-Ibuild/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/interpolate/src -I/usr/lib64/python2.7/site-packages/numpy/core/include -I/usr/include/python2.7 -c' gfortran:f77: build/src.linux-ppc64le-2.7/scipy/interpolate/src/dfitpack-f2pywrappers.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran /usr/bin/gfortran -Wall -g -Wl,-z,relro -Wl,-z,now -specs=/usr/lib/rpm/redhat/redhat-hardened-ld -shared build/temp.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/interpolate/src/dfitpackmodule.o build/temp.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/interpolate/src/fortranobject.o build/temp.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/interpolate/src/dfitpack-f2pywrappers.o -L/usr/lib/gcc/ppc64le-redhat-linux/8 -L/usr/lib/gcc/ppc64le-redhat-linux/8 -L/usr/lib64 -Lbuild/temp.linux-ppc64le-2.7 -lfitpack -lpython2.7 -lgfortran -o build/lib.linux-ppc64le-2.7/scipy/interpolate/dfitpack.so building 'scipy.interpolate._interpolate' extension compiling C++ sources C compiler: g++ -pthread -fno-strict-aliasing -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -D_GNU_SOURCE -fPIC -fwrapv -DNDEBUG -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -D_GNU_SOURCE -fPIC -fwrapv -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -fPIC compile options: '-Iscipy/interpolate/src -I/usr/lib64/python2.7/site-packages/numpy/core/include -I/usr/include/python2.7 -c' g++: scipy/interpolate/src/_interpolate.cpp In file included from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/ndarraytypes.h:1816, from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/ndarrayobject.h:18, from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/arrayobject.h:4, from scipy/interpolate/src/_interpolate.cpp:5: /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/npy_1_7_deprecated_api.h:15:2: warning: #warning "Using deprecated NumPy API, disable it by " "#defining NPY_NO_DEPRECATED_API NPY_1_7_API_VERSION" [-Wcpp] #warning "Using deprecated NumPy API, disable it by " \ ^~~~~~~ g++ -pthread -shared -Wl,-z,relro -Wl,-z,now -specs=/usr/lib/rpm/redhat/redhat-hardened-ld -Wl,-z,relro -Wl,-z,now -specs=/usr/lib/rpm/redhat/redhat-hardened-ld -shared -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection build/temp.linux-ppc64le-2.7/scipy/interpolate/src/_interpolate.o -L/usr/lib64 -Lbuild/temp.linux-ppc64le-2.7 -lpython2.7 -o build/lib.linux-ppc64le-2.7/scipy/interpolate/_interpolate.so building 'scipy.io._test_fortran' extension compiling C sources C compiler: gcc -pthread -fno-strict-aliasing -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -D_GNU_SOURCE -fPIC -fwrapv -DNDEBUG -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -D_GNU_SOURCE -fPIC -fwrapv -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -fPIC creating build/temp.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/io creating build/temp.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/io compile options: '-Ibuild/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/io -I/usr/lib64/python2.7/site-packages/numpy/core/include -I/usr/include/python2.7 -c' gcc: build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/io/fortranobject.c In file included from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/ndarraytypes.h:1816, from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/ndarrayobject.h:18, from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/arrayobject.h:4, from build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/io/fortranobject.h:13, from build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/io/fortranobject.c:2: /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/npy_1_7_deprecated_api.h:15:2: warning: #warning "Using deprecated NumPy API, disable it by " "#defining NPY_NO_DEPRECATED_API NPY_1_7_API_VERSION" [-Wcpp] #warning "Using deprecated NumPy API, disable it by " \ ^~~~~~~ gcc: build/src.linux-ppc64le-2.7/scipy/io/_test_fortranmodule.c In file included from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/ndarraytypes.h:1816, from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/ndarrayobject.h:18, from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/arrayobject.h:4, from build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/io/fortranobject.h:13, from build/src.linux-ppc64le-2.7/scipy/io/_test_fortranmodule.c:16: /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/npy_1_7_deprecated_api.h:15:2: warning: #warning "Using deprecated NumPy API, disable it by " "#defining NPY_NO_DEPRECATED_API NPY_1_7_API_VERSION" [-Wcpp] #warning "Using deprecated NumPy API, disable it by " \ ^~~~~~~ build/src.linux-ppc64le-2.7/scipy/io/_test_fortranmodule.c:134:12: warning: 'f2py_size' defined but not used [-Wunused-function] static int f2py_size(PyArrayObject* var, ...) ^~~~~~~~~ compiling Fortran sources Fortran f77 compiler: /usr/bin/gfortran -Wall -g -ffixed-form -fno-second-underscore -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -fPIC -cpp -O3 -funroll-loops Fortran f90 compiler: /usr/bin/gfortran -Wall -g -fno-second-underscore -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -fPIC -cpp -O3 -funroll-loops Fortran fix compiler: /usr/bin/gfortran -Wall -g -ffixed-form -fno-second-underscore -Wall -g -fno-second-underscore -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -fPIC -cpp -O3 -funroll-loops creating build/temp.linux-ppc64le-2.7/scipy/io compile options: '-Ibuild/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/io -I/usr/lib64/python2.7/site-packages/numpy/core/include -I/usr/include/python2.7 -c' gfortran:f77: scipy/io/_test_fortran.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran /usr/bin/gfortran -Wall -g -Wl,-z,relro -Wl,-z,now -specs=/usr/lib/rpm/redhat/redhat-hardened-ld -shared build/temp.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/io/_test_fortranmodule.o build/temp.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/io/fortranobject.o build/temp.linux-ppc64le-2.7/scipy/io/_test_fortran.o -L/usr/lib/gcc/ppc64le-redhat-linux/8 -L/usr/lib/gcc/ppc64le-redhat-linux/8 -L/usr/lib64 -Lbuild/temp.linux-ppc64le-2.7 -lpython2.7 -lgfortran -o build/lib.linux-ppc64le-2.7/scipy/io/_test_fortran.so building 'scipy.io.matlab.streams' extension compiling C sources C compiler: gcc -pthread -fno-strict-aliasing -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -D_GNU_SOURCE -fPIC -fwrapv -DNDEBUG -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -D_GNU_SOURCE -fPIC -fwrapv -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -fPIC creating build/temp.linux-ppc64le-2.7/scipy/io/matlab compile options: '-I/usr/lib64/python2.7/site-packages/numpy/core/include -I/usr/include/python2.7 -c' gcc: scipy/io/matlab/streams.c gcc -pthread -shared -Wl,-z,relro -Wl,-z,now -specs=/usr/lib/rpm/redhat/redhat-hardened-ld -Wl,-z,relro -Wl,-z,now -specs=/usr/lib/rpm/redhat/redhat-hardened-ld -shared -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection build/temp.linux-ppc64le-2.7/scipy/io/matlab/streams.o -L/usr/lib64 -Lbuild/temp.linux-ppc64le-2.7 -lpython2.7 -o build/lib.linux-ppc64le-2.7/scipy/io/matlab/streams.so building 'scipy.io.matlab.mio_utils' extension compiling C sources C compiler: gcc -pthread -fno-strict-aliasing -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -D_GNU_SOURCE -fPIC -fwrapv -DNDEBUG -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -D_GNU_SOURCE -fPIC -fwrapv -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -fPIC compile options: '-I/usr/lib64/python2.7/site-packages/numpy/core/include -I/usr/include/python2.7 -c' gcc: scipy/io/matlab/mio_utils.c In file included from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/ndarraytypes.h:1816, from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/ndarrayobject.h:18, from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/arrayobject.h:4, from scipy/io/matlab/mio_utils.c:435: /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/npy_1_7_deprecated_api.h:15:2: warning: #warning "Using deprecated NumPy API, disable it by " "#defining NPY_NO_DEPRECATED_API NPY_1_7_API_VERSION" [-Wcpp] #warning "Using deprecated NumPy API, disable it by " \ ^~~~~~~ gcc -pthread -shared -Wl,-z,relro -Wl,-z,now -specs=/usr/lib/rpm/redhat/redhat-hardened-ld -Wl,-z,relro -Wl,-z,now -specs=/usr/lib/rpm/redhat/redhat-hardened-ld -shared -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection build/temp.linux-ppc64le-2.7/scipy/io/matlab/mio_utils.o -L/usr/lib64 -Lbuild/temp.linux-ppc64le-2.7 -lpython2.7 -o build/lib.linux-ppc64le-2.7/scipy/io/matlab/mio_utils.so building 'scipy.io.matlab.mio5_utils' extension compiling C sources C compiler: gcc -pthread -fno-strict-aliasing -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -D_GNU_SOURCE -fPIC -fwrapv -DNDEBUG -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -D_GNU_SOURCE -fPIC -fwrapv -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -fPIC compile options: '-I/usr/lib64/python2.7/site-packages/numpy/core/include -I/usr/include/python2.7 -c' gcc: scipy/io/matlab/mio5_utils.c In file included from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/ndarraytypes.h:1816, from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/ndarrayobject.h:18, from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/arrayobject.h:4, from scipy/io/matlab/mio5_utils.c:436: /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/npy_1_7_deprecated_api.h:15:2: warning: #warning "Using deprecated NumPy API, disable it by " "#defining NPY_NO_DEPRECATED_API NPY_1_7_API_VERSION" [-Wcpp] #warning "Using deprecated NumPy API, disable it by " \ ^~~~~~~ gcc -pthread -shared -Wl,-z,relro -Wl,-z,now -specs=/usr/lib/rpm/redhat/redhat-hardened-ld -Wl,-z,relro -Wl,-z,now -specs=/usr/lib/rpm/redhat/redhat-hardened-ld -shared -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection build/temp.linux-ppc64le-2.7/scipy/io/matlab/mio5_utils.o -L/usr/lib64 -Lbuild/temp.linux-ppc64le-2.7 -lpython2.7 -o build/lib.linux-ppc64le-2.7/scipy/io/matlab/mio5_utils.so building 'scipy.linalg._fblas' extension compiling C sources C compiler: gcc -pthread -fno-strict-aliasing -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -D_GNU_SOURCE -fPIC -fwrapv -DNDEBUG -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -D_GNU_SOURCE -fPIC -fwrapv -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -fPIC creating build/temp.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/linalg creating build/temp.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/build creating build/temp.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7 creating build/temp.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy creating build/temp.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/linalg compile options: '-DHAVE_CBLAS -Ibuild/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/linalg -I/usr/lib64/python2.7/site-packages/numpy/core/include -I/usr/include/python2.7 -c' gcc: build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/linalg/_fblasmodule.c In file included from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/ndarraytypes.h:1816, from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/ndarrayobject.h:18, from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/arrayobject.h:4, from build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/linalg/fortranobject.h:13, from build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/linalg/_fblasmodule.c:16: /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/npy_1_7_deprecated_api.h:15:2: warning: #warning "Using deprecated NumPy API, disable it by " "#defining NPY_NO_DEPRECATED_API NPY_1_7_API_VERSION" [-Wcpp] #warning "Using deprecated NumPy API, disable it by " \ ^~~~~~~ build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/linalg/_fblasmodule.c: In function 'init_fblas': build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/linalg/_fblasmodule.c:27299:3: warning: this 'for' clause does not guard... [-Wmisleading-indentation] for(i=0;f2py_routine_defs[i].name!=NULL;i++) ^~~ build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/linalg/_fblasmodule.c:27332:5: note: ...this statement, but the latter is misleadingly indented as if it were guarded by the 'for' { ^ At top level: build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/linalg/_fblasmodule.c:152:12: warning: 'f2py_size' defined but not used [-Wunused-function] static int f2py_size(PyArrayObject* var, ...) ^~~~~~~~~ gcc: build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/linalg/fortranobject.c In file included from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/ndarraytypes.h:1816, from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/ndarrayobject.h:18, from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/arrayobject.h:4, from build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/linalg/fortranobject.h:13, from build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/linalg/fortranobject.c:2: /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/npy_1_7_deprecated_api.h:15:2: warning: #warning "Using deprecated NumPy API, disable it by " "#defining NPY_NO_DEPRECATED_API NPY_1_7_API_VERSION" [-Wcpp] #warning "Using deprecated NumPy API, disable it by " \ ^~~~~~~ compiling Fortran sources Fortran f77 compiler: /usr/bin/gfortran -Wall -g -ffixed-form -fno-second-underscore -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -fPIC -cpp -O3 -funroll-loops Fortran f90 compiler: /usr/bin/gfortran -Wall -g -fno-second-underscore -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -fPIC -cpp -O3 -funroll-loops Fortran fix compiler: /usr/bin/gfortran -Wall -g -ffixed-form -fno-second-underscore -Wall -g -fno-second-underscore -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -fPIC -cpp -O3 -funroll-loops compile options: '-DHAVE_CBLAS -Ibuild/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/linalg -I/usr/lib64/python2.7/site-packages/numpy/core/include -I/usr/include/python2.7 -c' gfortran:f77: /builddir/build/BUILD/scipy-1.0.0/scipy/_build_utils/src/wrap_dummy_g77_abi.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: /builddir/build/BUILD/scipy-1.0.0/scipy/_build_utils/src/wrap_dummy_accelerate.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/linalg/_fblas-f2pywrappers.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran /usr/bin/gfortran -Wall -g -Wl,-z,relro -Wl,-z,now -specs=/usr/lib/rpm/redhat/redhat-hardened-ld -shared build/temp.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/linalg/_fblasmodule.o build/temp.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/linalg/fortranobject.o build/temp.linux-ppc64le-2.7/builddir/build/BUILD/scipy-1.0.0/scipy/_build_utils/src/wrap_dummy_g77_abi.o build/temp.linux-ppc64le-2.7/builddir/build/BUILD/scipy-1.0.0/scipy/_build_utils/src/wrap_dummy_accelerate.o build/temp.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/linalg/_fblas-f2pywrappers.o -L/usr/lib64 -L/usr/lib/gcc/ppc64le-redhat-linux/8 -L/usr/lib/gcc/ppc64le-redhat-linux/8 -L/usr/lib64 -Lbuild/temp.linux-ppc64le-2.7 -Wl,-rpath="/usr/lib64" -lopenblasp -lopenblas -lpython2.7 -lgfortran -o build/lib.linux-ppc64le-2.7/scipy/linalg/_fblas.so building 'scipy.linalg._flapack' extension compiling C sources C compiler: gcc -pthread -fno-strict-aliasing -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -D_GNU_SOURCE -fPIC -fwrapv -DNDEBUG -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -D_GNU_SOURCE -fPIC -fwrapv -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -fPIC compile options: '-DHAVE_CBLAS -Ibuild/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/linalg -I/usr/lib64/python2.7/site-packages/numpy/core/include -I/usr/include/python2.7 -c' gcc: build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/linalg/_flapackmodule.c In file included from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/ndarraytypes.h:1816, from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/ndarrayobject.h:18, from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/arrayobject.h:4, from build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/linalg/fortranobject.h:13, from build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/linalg/_flapackmodule.c:16: /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/npy_1_7_deprecated_api.h:15:2: warning: #warning "Using deprecated NumPy API, disable it by " "#defining NPY_NO_DEPRECATED_API NPY_1_7_API_VERSION" [-Wcpp] #warning "Using deprecated NumPy API, disable it by " \ ^~~~~~~ build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/linalg/_flapackmodule.c: In function 'f2py_rout__flapack_sgges': build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/linalg/_flapackmodule.c:3399:46: warning: variable 'sselect_cptr' set but not used [-Wunused-but-set-variable] cb_sselect_in_gges__user__routines_typedef sselect_cptr; ^~~~~~~~~~~~ build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/linalg/_flapackmodule.c: In function 'f2py_rout__flapack_dgges': build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/linalg/_flapackmodule.c:3758:46: warning: variable 'dselect_cptr' set but not used [-Wunused-but-set-variable] cb_dselect_in_gges__user__routines_typedef dselect_cptr; ^~~~~~~~~~~~ build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/linalg/_flapackmodule.c: In function 'f2py_rout__flapack_cgges': build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/linalg/_flapackmodule.c:4115:46: warning: variable 'cselect_cptr' set but not used [-Wunused-but-set-variable] cb_cselect_in_gges__user__routines_typedef cselect_cptr; ^~~~~~~~~~~~ build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/linalg/_flapackmodule.c: In function 'f2py_rout__flapack_zgges': build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/linalg/_flapackmodule.c:4473:46: warning: variable 'zselect_cptr' set but not used [-Wunused-but-set-variable] cb_zselect_in_gges__user__routines_typedef zselect_cptr; ^~~~~~~~~~~~ build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/linalg/_flapackmodule.c: In function 'f2py_rout__flapack_cgees': build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/linalg/_flapackmodule.c:48242:46: warning: variable 'cselect_cptr' set but not used [-Wunused-but-set-variable] cb_cselect_in_gees__user__routines_typedef cselect_cptr; ^~~~~~~~~~~~ build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/linalg/_flapackmodule.c: In function 'f2py_rout__flapack_zgees': build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/linalg/_flapackmodule.c:48513:46: warning: variable 'zselect_cptr' set but not used [-Wunused-but-set-variable] cb_zselect_in_gees__user__routines_typedef zselect_cptr; ^~~~~~~~~~~~ build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/linalg/_flapackmodule.c: In function 'f2py_rout__flapack_sgees': build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/linalg/_flapackmodule.c:48786:46: warning: variable 'sselect_cptr' set but not used [-Wunused-but-set-variable] cb_sselect_in_gees__user__routines_typedef sselect_cptr; ^~~~~~~~~~~~ build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/linalg/_flapackmodule.c: In function 'f2py_rout__flapack_dgees': build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/linalg/_flapackmodule.c:49058:46: warning: variable 'dselect_cptr' set but not used [-Wunused-but-set-variable] cb_dselect_in_gees__user__routines_typedef dselect_cptr; ^~~~~~~~~~~~ build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/linalg/_flapackmodule.c: In function 'f2py_rout__flapack_sstebz': build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/linalg/_flapackmodule.c:52032:116: warning: passing argument 16 of 'f2py_func' from incompatible pointer type [-Wincompatible-pointer-types] (*f2py_func)((range>0?(range==1?"V":"I"):"A"),order,&n,&vl,&vu,&il,&iu,&tol,d,e,&m,&nsplit,w,iblock,isplit,work,iwork,&info); ^~~~ build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/linalg/_flapackmodule.c:52032:116: note: expected 'int *' but argument is of type 'float *' build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/linalg/_flapackmodule.c: In function 'f2py_rout__flapack_dstebz': build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/linalg/_flapackmodule.c:52302:116: warning: passing argument 16 of 'f2py_func' from incompatible pointer type [-Wincompatible-pointer-types] (*f2py_func)((range>0?(range==1?"V":"I"):"A"),order,&n,&vl,&vu,&il,&iu,&tol,d,e,&m,&nsplit,w,iblock,isplit,work,iwork,&info); ^~~~ build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/linalg/_flapackmodule.c:52302:116: note: expected 'int *' but argument is of type 'double *' build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/linalg/_flapackmodule.c: In function 'f2py_rout__flapack_slange': build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/linalg/_flapackmodule.c:62897:7: warning: variable 'lda' set but not used [-Wunused-but-set-variable] int lda = 0; ^~~ build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/linalg/_flapackmodule.c: In function 'f2py_rout__flapack_dlange': build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/linalg/_flapackmodule.c:63027:7: warning: variable 'lda' set but not used [-Wunused-but-set-variable] int lda = 0; ^~~ build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/linalg/_flapackmodule.c: In function 'f2py_rout__flapack_clange': build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/linalg/_flapackmodule.c:63157:7: warning: variable 'lda' set but not used [-Wunused-but-set-variable] int lda = 0; ^~~ build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/linalg/_flapackmodule.c: In function 'f2py_rout__flapack_zlange': build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/linalg/_flapackmodule.c:63287:7: warning: variable 'lda' set but not used [-Wunused-but-set-variable] int lda = 0; ^~~ build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/linalg/_flapackmodule.c: In function 'init_flapack': build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/linalg/_flapackmodule.c:66156:3: warning: this 'for' clause does not guard... [-Wmisleading-indentation] for(i=0;f2py_routine_defs[i].name!=NULL;i++) ^~~ build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/linalg/_flapackmodule.c:66461:5: note: ...this statement, but the latter is misleadingly indented as if it were guarded by the 'for' { ^ At top level: build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/linalg/_flapackmodule.c:334:12: warning: 'f2py_size' defined but not used [-Wunused-function] static int f2py_size(PyArrayObject* var, ...) ^~~~~~~~~ compiling Fortran sources Fortran f77 compiler: /usr/bin/gfortran -Wall -g -ffixed-form -fno-second-underscore -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -fPIC -cpp -O3 -funroll-loops Fortran f90 compiler: /usr/bin/gfortran -Wall -g -fno-second-underscore -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -fPIC -cpp -O3 -funroll-loops Fortran fix compiler: /usr/bin/gfortran -Wall -g -ffixed-form -fno-second-underscore -Wall -g -fno-second-underscore -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -fPIC -cpp -O3 -funroll-loops creating build/temp.linux-ppc64le-2.7/scipy/linalg/src creating build/temp.linux-ppc64le-2.7/scipy/linalg/src/lapack_deprecations compile options: '-DHAVE_CBLAS -Ibuild/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/linalg -I/usr/lib64/python2.7/site-packages/numpy/core/include -I/usr/include/python2.7 -c' gfortran:f77: /builddir/build/BUILD/scipy-1.0.0/scipy/_build_utils/src/wrap_dummy_g77_abi.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: /builddir/build/BUILD/scipy-1.0.0/scipy/_build_utils/src/wrap_dummy_accelerate.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/linalg/src/lapack_deprecations/cgegv.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran scipy/linalg/src/lapack_deprecations/cgegv.f:693:20: SBETA = ( SCALE*BETA( JC ) )*BNRM 1 Warning: Possible change of value in conversion from COMPLEX(4) to REAL(4) at (1) [-Wconversion] gfortran:f77: scipy/linalg/src/lapack_deprecations/dgegv.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/linalg/src/lapack_deprecations/sgegv.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/linalg/src/lapack_deprecations/zgegv.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran scipy/linalg/src/lapack_deprecations/zgegv.f:693:20: SBETA = ( SCALE*BETA( JC ) )*BNRM 1 Warning: Possible change of value in conversion from COMPLEX(8) to REAL(8) at (1) [-Wconversion] gfortran:f77: build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/linalg/_flapack-f2pywrappers.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran /usr/bin/gfortran -Wall -g -Wl,-z,relro -Wl,-z,now -specs=/usr/lib/rpm/redhat/redhat-hardened-ld -shared build/temp.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/linalg/_flapackmodule.o build/temp.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/linalg/fortranobject.o build/temp.linux-ppc64le-2.7/builddir/build/BUILD/scipy-1.0.0/scipy/_build_utils/src/wrap_dummy_g77_abi.o build/temp.linux-ppc64le-2.7/builddir/build/BUILD/scipy-1.0.0/scipy/_build_utils/src/wrap_dummy_accelerate.o build/temp.linux-ppc64le-2.7/scipy/linalg/src/lapack_deprecations/cgegv.o build/temp.linux-ppc64le-2.7/scipy/linalg/src/lapack_deprecations/dgegv.o build/temp.linux-ppc64le-2.7/scipy/linalg/src/lapack_deprecations/sgegv.o build/temp.linux-ppc64le-2.7/scipy/linalg/src/lapack_deprecations/zgegv.o build/temp.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/linalg/_flapack-f2pywrappers.o -L/usr/lib64 -L/usr/lib/gcc/ppc64le-redhat-linux/8 -L/usr/lib/gcc/ppc64le-redhat-linux/8 -L/usr/lib64 -Lbuild/temp.linux-ppc64le-2.7 -Wl,-rpath="/usr/lib64" -lopenblasp -lopenblas -lpython2.7 -lgfortran -o build/lib.linux-ppc64le-2.7/scipy/linalg/_flapack.so building 'scipy.linalg._flinalg' extension compiling C sources C compiler: gcc -pthread -fno-strict-aliasing -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -D_GNU_SOURCE -fPIC -fwrapv -DNDEBUG -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -D_GNU_SOURCE -fPIC -fwrapv -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -fPIC creating build/temp.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/linalg compile options: '-DHAVE_CBLAS -Ibuild/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/linalg -I/usr/lib64/python2.7/site-packages/numpy/core/include -I/usr/include/python2.7 -c' gcc: build/src.linux-ppc64le-2.7/scipy/linalg/_flinalgmodule.c In file included from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/ndarraytypes.h:1816, from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/ndarrayobject.h:18, from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/arrayobject.h:4, from build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/linalg/fortranobject.h:13, from build/src.linux-ppc64le-2.7/scipy/linalg/_flinalgmodule.c:16: /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/npy_1_7_deprecated_api.h:15:2: warning: #warning "Using deprecated NumPy API, disable it by " "#defining NPY_NO_DEPRECATED_API NPY_1_7_API_VERSION" [-Wcpp] #warning "Using deprecated NumPy API, disable it by " \ ^~~~~~~ build/src.linux-ppc64le-2.7/scipy/linalg/_flinalgmodule.c:110:12: warning: 'f2py_size' defined but not used [-Wunused-function] static int f2py_size(PyArrayObject* var, ...) ^~~~~~~~~ gcc: build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/linalg/fortranobject.c In file included from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/ndarraytypes.h:1816, from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/ndarrayobject.h:18, from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/arrayobject.h:4, from build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/linalg/fortranobject.h:13, from build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/linalg/fortranobject.c:2: /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/npy_1_7_deprecated_api.h:15:2: warning: #warning "Using deprecated NumPy API, disable it by " "#defining NPY_NO_DEPRECATED_API NPY_1_7_API_VERSION" [-Wcpp] #warning "Using deprecated NumPy API, disable it by " \ ^~~~~~~ compiling Fortran sources Fortran f77 compiler: /usr/bin/gfortran -Wall -g -ffixed-form -fno-second-underscore -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -fPIC -cpp -O3 -funroll-loops Fortran f90 compiler: /usr/bin/gfortran -Wall -g -fno-second-underscore -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -fPIC -cpp -O3 -funroll-loops Fortran fix compiler: /usr/bin/gfortran -Wall -g -ffixed-form -fno-second-underscore -Wall -g -fno-second-underscore -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -fPIC -cpp -O3 -funroll-loops compile options: '-DHAVE_CBLAS -Ibuild/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/linalg -I/usr/lib64/python2.7/site-packages/numpy/core/include -I/usr/include/python2.7 -c' gfortran:f77: scipy/linalg/src/det.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/linalg/src/lu.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran /usr/bin/gfortran -Wall -g -Wl,-z,relro -Wl,-z,now -specs=/usr/lib/rpm/redhat/redhat-hardened-ld -shared build/temp.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/linalg/_flinalgmodule.o build/temp.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/linalg/fortranobject.o build/temp.linux-ppc64le-2.7/scipy/linalg/src/det.o build/temp.linux-ppc64le-2.7/scipy/linalg/src/lu.o -L/usr/lib64 -L/usr/lib/gcc/ppc64le-redhat-linux/8 -L/usr/lib/gcc/ppc64le-redhat-linux/8 -L/usr/lib64 -Lbuild/temp.linux-ppc64le-2.7 -Wl,-rpath="/usr/lib64" -lopenblasp -lopenblas -lpython2.7 -lgfortran -o build/lib.linux-ppc64le-2.7/scipy/linalg/_flinalg.so building 'scipy.linalg._interpolative' extension compiling C sources C compiler: gcc -pthread -fno-strict-aliasing -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -D_GNU_SOURCE -fPIC -fwrapv -DNDEBUG -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -D_GNU_SOURCE -fPIC -fwrapv -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -fPIC compile options: '-DHAVE_CBLAS -Ibuild/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/linalg -I/usr/lib64/python2.7/site-packages/numpy/core/include -I/usr/include/python2.7 -c' gcc: build/src.linux-ppc64le-2.7/scipy/linalg/_interpolativemodule.c In file included from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/ndarraytypes.h:1816, from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/ndarrayobject.h:18, from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/arrayobject.h:4, from build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/linalg/fortranobject.h:13, from build/src.linux-ppc64le-2.7/scipy/linalg/_interpolativemodule.c:16: /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/npy_1_7_deprecated_api.h:15:2: warning: #warning "Using deprecated NumPy API, disable it by " "#defining NPY_NO_DEPRECATED_API NPY_1_7_API_VERSION" [-Wcpp] #warning "Using deprecated NumPy API, disable it by " \ ^~~~~~~ build/src.linux-ppc64le-2.7/scipy/linalg/_interpolativemodule.c:144:12: warning: 'f2py_size' defined but not used [-Wunused-function] static int f2py_size(PyArrayObject* var, ...) ^~~~~~~~~ compiling Fortran sources Fortran f77 compiler: /usr/bin/gfortran -Wall -g -ffixed-form -fno-second-underscore -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -fPIC -cpp -O3 -funroll-loops Fortran f90 compiler: /usr/bin/gfortran -Wall -g -fno-second-underscore -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -fPIC -cpp -O3 -funroll-loops Fortran fix compiler: /usr/bin/gfortran -Wall -g -ffixed-form -fno-second-underscore -Wall -g -fno-second-underscore -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -fPIC -cpp -O3 -funroll-loops creating build/temp.linux-ppc64le-2.7/scipy/linalg/src/id_dist creating build/temp.linux-ppc64le-2.7/scipy/linalg/src/id_dist/src compile options: '-DHAVE_CBLAS -Ibuild/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/linalg -I/usr/lib64/python2.7/site-packages/numpy/core/include -I/usr/include/python2.7 -c' gfortran:f77: scipy/linalg/src/id_dist/src/idz_svd_subr_0.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/linalg/src/id_dist/src/idz_svd_subr_1.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/linalg/src/id_dist/src/idz_svd_subr_2.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/linalg/src/id_dist/src/idz_svd_subr_3.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/linalg/src/id_dist/src/idz_qrpiv.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran scipy/linalg/src/id_dist/src/idz_qrpiv.f:491:20: ss(k) = ss(k)+a(j,k)*conjg(a(j,k)) 1 Warning: Possible change of value in conversion from COMPLEX(8) to REAL(8) at (1) [-Wconversion] scipy/linalg/src/id_dist/src/idz_qrpiv.f:573:22: ss(k) = ss(k)-a(krank,k)*conjg(a(krank,k)) 1 Warning: Possible change of value in conversion from COMPLEX(8) to REAL(8) at (1) [-Wconversion] scipy/linalg/src/id_dist/src/idz_qrpiv.f:621:28: ss(k) = ss(k)+a(j,k)*conjg(a(j,k)) 1 Warning: Possible change of value in conversion from COMPLEX(8) to REAL(8) at (1) [-Wconversion] scipy/linalg/src/id_dist/src/idz_qrpiv.f:749:20: ss(k) = ss(k)+a(j,k)*conjg(a(j,k)) 1 Warning: Possible change of value in conversion from COMPLEX(8) to REAL(8) at (1) [-Wconversion] scipy/linalg/src/id_dist/src/idz_qrpiv.f:828:22: ss(k) = ss(k)-a(loop,k)*conjg(a(loop,k)) 1 Warning: Possible change of value in conversion from COMPLEX(8) to REAL(8) at (1) [-Wconversion] scipy/linalg/src/id_dist/src/idz_qrpiv.f:876:28: ss(k) = ss(k)+a(j,k)*conjg(a(j,k)) 1 Warning: Possible change of value in conversion from COMPLEX(8) to REAL(8) at (1) [-Wconversion] gfortran:f77: scipy/linalg/src/id_dist/src/idzp_rsvd_subr_0.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/linalg/src/id_dist/src/idzp_rsvd_subr_1.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran scipy/linalg/src/id_dist/src/idzp_rsvd_subr_1.f:1:41: subroutine idzp_rsvd0(m,n,matveca,p1t,p2t,p3t,p4t, 1 Warning: Unused dummy argument 'matveca' at (1) [-Wunused-dummy-argument] scipy/linalg/src/id_dist/src/idzp_rsvd_subr_1.f:1:45: subroutine idzp_rsvd0(m,n,matveca,p1t,p2t,p3t,p4t, 1 Warning: Unused dummy argument 'p1t' at (1) [-Wunused-dummy-argument] scipy/linalg/src/id_dist/src/idzp_rsvd_subr_1.f:1:49: subroutine idzp_rsvd0(m,n,matveca,p1t,p2t,p3t,p4t, 1 Warning: Unused dummy argument 'p2t' at (1) [-Wunused-dummy-argument] scipy/linalg/src/id_dist/src/idzp_rsvd_subr_1.f:1:53: subroutine idzp_rsvd0(m,n,matveca,p1t,p2t,p3t,p4t, 1 Warning: Unused dummy argument 'p3t' at (1) [-Wunused-dummy-argument] scipy/linalg/src/id_dist/src/idzp_rsvd_subr_1.f:1:57: subroutine idzp_rsvd0(m,n,matveca,p1t,p2t,p3t,p4t, 1 Warning: Unused dummy argument 'p4t' at (1) [-Wunused-dummy-argument] gfortran:f77: scipy/linalg/src/id_dist/src/idzp_rsvd_subr_2.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/linalg/src/id_dist/src/idzr_rid.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/linalg/src/id_dist/src/iddr_asvd_subr_0.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/linalg/src/id_dist/src/iddr_asvd_subr_1.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/linalg/src/id_dist/src/idzr_asvd_subr_0.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/linalg/src/id_dist/src/idzr_asvd_subr_1.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/linalg/src/id_dist/src/iddr_rsvd_subr_0.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/linalg/src/id_dist/src/iddr_rsvd_subr_1.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/linalg/src/id_dist/src/idd_id.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran scipy/linalg/src/id_dist/src/idd_id.f:106:20: iswap = rnorms(k) 1 Warning: Possible change of value in conversion from REAL(8) to INTEGER(4) at (1) [-Wconversion] scipy/linalg/src/id_dist/src/idd_id.f:114:20: list(k) = rnorms(k) 1 Warning: Possible change of value in conversion from REAL(8) to INTEGER(4) at (1) [-Wconversion] scipy/linalg/src/id_dist/src/idd_id.f:218:20: iswap = rnorms(k) 1 Warning: Possible change of value in conversion from REAL(8) to INTEGER(4) at (1) [-Wconversion] scipy/linalg/src/id_dist/src/idd_id.f:226:20: list(k) = rnorms(k) 1 Warning: Possible change of value in conversion from REAL(8) to INTEGER(4) at (1) [-Wconversion] gfortran:f77: scipy/linalg/src/id_dist/src/idd_qrpiv.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/linalg/src/id_dist/src/idz_sfft.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/linalg/src/id_dist/src/idzr_rsvd_subr_0.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/linalg/src/id_dist/src/idzr_rsvd_subr_1.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/linalg/src/id_dist/src/id_rtrans_subr_0.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran scipy/linalg/src/id_dist/src/id_rtrans_subr_0.f:145:17: ialbetas=w(1) 1 Warning: Possible change of value in conversion from REAL(8) to INTEGER(4) at (1) [-Wconversion] scipy/linalg/src/id_dist/src/id_rtrans_subr_0.f:146:13: iixs=w(2) 1 Warning: Possible change of value in conversion from REAL(8) to INTEGER(4) at (1) [-Wconversion] scipy/linalg/src/id_dist/src/id_rtrans_subr_0.f:147:15: nsteps=w(3) 1 Warning: Possible change of value in conversion from REAL(8) to INTEGER(4) at (1) [-Wconversion] scipy/linalg/src/id_dist/src/id_rtrans_subr_0.f:148:12: iww=w(4) 1 Warning: Possible change of value in conversion from REAL(8) to INTEGER(4) at (1) [-Wconversion] scipy/linalg/src/id_dist/src/id_rtrans_subr_0.f:149:10: n=w(5) 1 Warning: Possible change of value in conversion from REAL(8) to INTEGER(4) at (1) [-Wconversion] scipy/linalg/src/id_dist/src/id_rtrans_subr_0.f:185:17: ialbetas=w(1) 1 Warning: Possible change of value in conversion from REAL(8) to INTEGER(4) at (1) [-Wconversion] scipy/linalg/src/id_dist/src/id_rtrans_subr_0.f:186:13: iixs=w(2) 1 Warning: Possible change of value in conversion from REAL(8) to INTEGER(4) at (1) [-Wconversion] scipy/linalg/src/id_dist/src/id_rtrans_subr_0.f:187:15: nsteps=w(3) 1 Warning: Possible change of value in conversion from REAL(8) to INTEGER(4) at (1) [-Wconversion] scipy/linalg/src/id_dist/src/id_rtrans_subr_0.f:188:12: iww=w(4) 1 Warning: Possible change of value in conversion from REAL(8) to INTEGER(4) at (1) [-Wconversion] scipy/linalg/src/id_dist/src/id_rtrans_subr_0.f:189:10: n=w(5) 1 Warning: Possible change of value in conversion from REAL(8) to INTEGER(4) at (1) [-Wconversion] scipy/linalg/src/id_dist/src/id_rtrans_subr_0.f:223:17: ialbetas=w(1) 1 Warning: Possible change of value in conversion from REAL(8) to INTEGER(4) at (1) [-Wconversion] scipy/linalg/src/id_dist/src/id_rtrans_subr_0.f:224:13: iixs=w(2) 1 Warning: Possible change of value in conversion from REAL(8) to INTEGER(4) at (1) [-Wconversion] scipy/linalg/src/id_dist/src/id_rtrans_subr_0.f:225:15: nsteps=w(3) 1 Warning: Possible change of value in conversion from REAL(8) to INTEGER(4) at (1) [-Wconversion] scipy/linalg/src/id_dist/src/id_rtrans_subr_0.f:226:12: iww=w(4) 1 Warning: Possible change of value in conversion from REAL(8) to INTEGER(4) at (1) [-Wconversion] scipy/linalg/src/id_dist/src/id_rtrans_subr_0.f:227:10: n=w(5) 1 Warning: Possible change of value in conversion from REAL(8) to INTEGER(4) at (1) [-Wconversion] scipy/linalg/src/id_dist/src/id_rtrans_subr_0.f:228:16: igammas=w(6) 1 Warning: Possible change of value in conversion from REAL(8) to INTEGER(4) at (1) [-Wconversion] scipy/linalg/src/id_dist/src/id_rtrans_subr_0.f:265:17: ialbetas=w(1) 1 Warning: Possible change of value in conversion from REAL(8) to INTEGER(4) at (1) [-Wconversion] scipy/linalg/src/id_dist/src/id_rtrans_subr_0.f:266:13: iixs=w(2) 1 Warning: Possible change of value in conversion from REAL(8) to INTEGER(4) at (1) [-Wconversion] scipy/linalg/src/id_dist/src/id_rtrans_subr_0.f:267:15: nsteps=w(3) 1 Warning: Possible change of value in conversion from REAL(8) to INTEGER(4) at (1) [-Wconversion] scipy/linalg/src/id_dist/src/id_rtrans_subr_0.f:268:12: iww=w(4) 1 Warning: Possible change of value in conversion from REAL(8) to INTEGER(4) at (1) [-Wconversion] scipy/linalg/src/id_dist/src/id_rtrans_subr_0.f:269:10: n=w(5) 1 Warning: Possible change of value in conversion from REAL(8) to INTEGER(4) at (1) [-Wconversion] scipy/linalg/src/id_dist/src/id_rtrans_subr_0.f:270:16: igammas=w(6) 1 Warning: Possible change of value in conversion from REAL(8) to INTEGER(4) at (1) [-Wconversion] gfortran:f77: scipy/linalg/src/id_dist/src/id_rtrans_subr_1.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/linalg/src/id_dist/src/id_rtrans_subr_2.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/linalg/src/id_dist/src/id_rtrans_subr_3.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/linalg/src/id_dist/src/id_rtrans_subr_4.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/linalg/src/id_dist/src/id_rtrans_subr_5.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/linalg/src/id_dist/src/id_rtrans_subr_6.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/linalg/src/id_dist/src/id_rtrans_subr_7.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/linalg/src/id_dist/src/id_rtrans_subr_8.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/linalg/src/id_dist/src/id_rtrans_subr_9.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/linalg/src/id_dist/src/id_rtrans_subr_10.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/linalg/src/id_dist/src/id_rtrans_subr_11.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/linalg/src/id_dist/src/iddp_asvd_subr_0.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/linalg/src/id_dist/src/iddp_asvd_subr_1.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/linalg/src/id_dist/src/idd_frm_subr_0.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran scipy/linalg/src/id_dist/src/idd_frm_subr_0.f:37:13: iw = w(3+m+n) 1 Warning: Possible change of value in conversion from REAL(8) to INTEGER(4) at (1) [-Wconversion] scipy/linalg/src/id_dist/src/idd_frm_subr_0.f:104:13: l2 = w(3) 1 Warning: Possible change of value in conversion from REAL(8) to INTEGER(4) at (1) [-Wconversion] scipy/linalg/src/id_dist/src/idd_frm_subr_0.f:110:13: iw = w(4+m+l+l2) 1 Warning: Possible change of value in conversion from REAL(8) to INTEGER(4) at (1) [-Wconversion] gfortran:f77: scipy/linalg/src/id_dist/src/idd_frm_subr_1.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/linalg/src/id_dist/src/idd_frm_subr_2.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/linalg/src/id_dist/src/idd_frm_subr_3.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/linalg/src/id_dist/src/idd_frm_subr_4.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/linalg/src/id_dist/src/idd_frm_subr_5.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/linalg/src/id_dist/src/idd_frm_subr_6.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/linalg/src/id_dist/src/dfft_subr_0.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran f951: Warning: Nonconforming tab character in column 1 of line 6 [-Wtabs] gfortran:f77: scipy/linalg/src/id_dist/src/dfft_subr_1.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran f951: Warning: Nonconforming tab character in column 1 of line 6 [-Wtabs] gfortran:f77: scipy/linalg/src/id_dist/src/dfft_subr_2.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran f951: Warning: Nonconforming tab character in column 1 of line 6 [-Wtabs] gfortran:f77: scipy/linalg/src/id_dist/src/dfft_subr_3.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran f951: Warning: Nonconforming tab character in column 1 of line 6 [-Wtabs] gfortran:f77: scipy/linalg/src/id_dist/src/dfft_subr_4.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran f951: Warning: Nonconforming tab character in column 1 of line 6 [-Wtabs] gfortran:f77: scipy/linalg/src/id_dist/src/dfft_subr_5.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran f951: Warning: Nonconforming tab character in column 1 of line 6 [-Wtabs] f951: Warning: Nonconforming tab character in column 1 of line 16 [-Wtabs] f951: Warning: Nonconforming tab character in column 1 of line 45 [-Wtabs] f951: Warning: Nonconforming tab character in column 1 of line 71 [-Wtabs] f951: Warning: Nonconforming tab character in column 1 of line 84 [-Wtabs] gfortran:f77: scipy/linalg/src/id_dist/src/dfft_subr_6.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran f951: Warning: Nonconforming tab character in column 1 of line 6 [-Wtabs] gfortran:f77: scipy/linalg/src/id_dist/src/dfft_subr_7.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran f951: Warning: Nonconforming tab character in column 1 of line 6 [-Wtabs] f951: Warning: Nonconforming tab character in column 1 of line 20 [-Wtabs] f951: Warning: Nonconforming tab character in column 1 of line 32 [-Wtabs] f951: Warning: Nonconforming tab character in column 1 of line 52 [-Wtabs] f951: Warning: Nonconforming tab character in column 1 of line 74 [-Wtabs] f951: Warning: Nonconforming tab character in column 1 of line 101 [-Wtabs] f951: Warning: Nonconforming tab character in column 1 of line 108 [-Wtabs] f951: Warning: Nonconforming tab character in column 1 of line 225 [-Wtabs] f951: Warning: Nonconforming tab character in column 1 of line 249 [-Wtabs] f951: Warning: Nonconforming tab character in column 1 of line 292 [-Wtabs] f951: Warning: Nonconforming tab character in column 1 of line 344 [-Wtabs] f951: Warning: Nonconforming tab character in column 1 of line 423 [-Wtabs] f951: Warning: Nonconforming tab character in column 1 of line 540 [-Wtabs] f951: Warning: Nonconforming tab character in column 1 of line 564 [-Wtabs] f951: Warning: Nonconforming tab character in column 1 of line 607 [-Wtabs] f951: Warning: Nonconforming tab character in column 1 of line 659 [-Wtabs] f951: Warning: Nonconforming tab character in column 1 of line 738 [-Wtabs] f951: Warning: Nonconforming tab character in column 1 of line 766 [-Wtabs] f951: Warning: Nonconforming tab character in column 1 of line 804 [-Wtabs] f951: Warning: Nonconforming tab character in column 1 of line 862 [-Wtabs] f951: Warning: Nonconforming tab character in column 1 of line 929 [-Wtabs] f951: Warning: Nonconforming tab character in column 1 of line 1090 [-Wtabs] f951: Warning: Nonconforming tab character in column 1 of line 1118 [-Wtabs] f951: Warning: Nonconforming tab character in column 1 of line 1154 [-Wtabs] f951: Warning: Nonconforming tab character in column 1 of line 1208 [-Wtabs] f951: Warning: Nonconforming tab character in column 1 of line 1271 [-Wtabs] gfortran:f77: scipy/linalg/src/id_dist/src/dfft_subr_8.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran f951: Warning: Nonconforming tab character in column 1 of line 6 [-Wtabs] gfortran:f77: scipy/linalg/src/id_dist/src/dfft_subr_9.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran f951: Warning: Nonconforming tab character in column 1 of line 6 [-Wtabs] gfortran:f77: scipy/linalg/src/id_dist/src/dfft_subr_10.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran f951: Warning: Nonconforming tab character in column 1 of line 6 [-Wtabs] gfortran:f77: scipy/linalg/src/id_dist/src/dfft_subr_11.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran f951: Warning: Nonconforming tab character in column 1 of line 6 [-Wtabs] gfortran:f77: scipy/linalg/src/id_dist/src/dfft_subr_12.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran f951: Warning: Nonconforming tab character in column 1 of line 6 [-Wtabs] gfortran:f77: scipy/linalg/src/id_dist/src/dfft_subr_13.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran f951: Warning: Nonconforming tab character in column 1 of line 6 [-Wtabs] f951: Warning: Nonconforming tab character in column 1 of line 13 [-Wtabs] f951: Warning: Nonconforming tab character in column 1 of line 32 [-Wtabs] f951: Warning: Nonconforming tab character in column 1 of line 49 [-Wtabs] gfortran:f77: scipy/linalg/src/id_dist/src/dfft_subr_14.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran f951: Warning: Nonconforming tab character in column 1 of line 6 [-Wtabs] gfortran:f77: scipy/linalg/src/id_dist/src/dfft_subr_15.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran f951: Warning: Nonconforming tab character in column 1 of line 6 [-Wtabs] f951: Warning: Nonconforming tab character in column 1 of line 17 [-Wtabs] gfortran:f77: scipy/linalg/src/id_dist/src/iddp_rid.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran scipy/linalg/src/id_dist/src/iddp_rid.f:302:0: 1 .and. krank .lt. m .and. krank .lt. n) Warning: 'enorm' may be used uninitialized in this function [-Wmaybe-uninitialized] gfortran:f77: scipy/linalg/src/id_dist/src/idzr_aid.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran scipy/linalg/src/id_dist/src/idzr_aid.f:105:12: l = w(1) 1 Warning: Possible change of value in conversion from COMPLEX(8) to INTEGER(4) at (1) [-Wconversion] scipy/linalg/src/id_dist/src/idzr_aid.f:106:13: n2 = w(2) 1 Warning: Possible change of value in conversion from COMPLEX(8) to INTEGER(4) at (1) [-Wconversion] gfortran:f77: scipy/linalg/src/id_dist/src/idz_frm_subr_0.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran scipy/linalg/src/id_dist/src/idz_frm_subr_0.f:37:13: iw = w(3+m+n) 1 Warning: Possible change of value in conversion from COMPLEX(8) to INTEGER(4) at (1) [-Wconversion] scipy/linalg/src/id_dist/src/idz_frm_subr_0.f:104:13: iw = w(4+m+l) 1 Warning: Possible change of value in conversion from COMPLEX(8) to INTEGER(4) at (1) [-Wconversion] gfortran:f77: scipy/linalg/src/id_dist/src/idz_frm_subr_1.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/linalg/src/id_dist/src/idz_frm_subr_2.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/linalg/src/id_dist/src/idz_frm_subr_3.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/linalg/src/id_dist/src/idd_house.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/linalg/src/id_dist/src/idzp_rid.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran scipy/linalg/src/id_dist/src/idzp_rid.f:273:22: enorm = enorm + y(k)*conjg(y(k)) 1 Warning: Possible change of value in conversion from COMPLEX(8) to REAL(8) at (1) [-Wconversion] scipy/linalg/src/id_dist/src/idzp_rid.f:305:0: 1 .and. krank .lt. m .and. krank .lt. n) Warning: 'enorm' may be used uninitialized in this function [-Wmaybe-uninitialized] gfortran:f77: scipy/linalg/src/id_dist/src/idd_sfft.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran scipy/linalg/src/id_dist/src/idd_sfft.f:75:37: if(l .eq. 1) call idd_sffti1(ind,n,wsave) 1 Warning: Rank mismatch in argument 'ind' at (1) (scalar and rank-1) [-Wargument-mismatch] scipy/linalg/src/id_dist/src/idd_sfft.f:233:36: if(l .eq. 1) call idd_sfft1(ind,n,v,wsave) 1 Warning: Rank mismatch in argument 'ind' at (1) (scalar and rank-1) [-Wargument-mismatch] scipy/linalg/src/id_dist/src/idd_sfft.f:386:23: v(2*i-1) = sum 1 Warning: Possible change of value in conversion from COMPLEX(8) to REAL(8) at (1) [-Wconversion] scipy/linalg/src/id_dist/src/idd_sfft.f:387:21: v(2*i) = -ci*sum 1 Warning: Possible change of value in conversion from COMPLEX(8) to REAL(8) at (1) [-Wconversion] scipy/linalg/src/id_dist/src/idd_sfft.f:406:25: v(2*i-1) = sum 1 Warning: Possible change of value in conversion from COMPLEX(8) to REAL(8) at (1) [-Wconversion] scipy/linalg/src/id_dist/src/idd_sfft.f:407:23: v(2*i) = -ci*sum 1 Warning: Possible change of value in conversion from COMPLEX(8) to REAL(8) at (1) [-Wconversion] scipy/linalg/src/id_dist/src/idd_sfft.f:419:23: rsum = rsum + wsave(iii+m*(nblock/2)+k) 1 Warning: Possible change of value in conversion from COMPLEX(8) to REAL(8) at (1) [-Wconversion] scipy/linalg/src/id_dist/src/idd_sfft.f:428:23: rsum = rsum + wsave(iii+m*(nblock/2)+2*k-1) 1 Warning: Possible change of value in conversion from COMPLEX(8) to REAL(8) at (1) [-Wconversion] scipy/linalg/src/id_dist/src/idd_sfft.f:429:23: rsum = rsum - wsave(iii+m*(nblock/2)+2*k) 1 Warning: Possible change of value in conversion from COMPLEX(8) to REAL(8) at (1) [-Wconversion] scipy/linalg/src/id_dist/src/idd_sfft.f:305:0: v(2*ind-1) = sumr Warning: 'sumr' may be used uninitialized in this function [-Wmaybe-uninitialized] scipy/linalg/src/id_dist/src/idd_sfft.f:306:0: v(2*ind) = sumi Warning: 'sumi' may be used uninitialized in this function [-Wmaybe-uninitialized] gfortran:f77: scipy/linalg/src/id_dist/src/iddr_aid.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran scipy/linalg/src/id_dist/src/iddr_aid.f:104:12: l = w(1) 1 Warning: Possible change of value in conversion from REAL(8) to INTEGER(4) at (1) [-Wconversion] scipy/linalg/src/id_dist/src/iddr_aid.f:105:13: n2 = w(2) 1 Warning: Possible change of value in conversion from REAL(8) to INTEGER(4) at (1) [-Wconversion] gfortran:f77: scipy/linalg/src/id_dist/src/idd_snorm.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/linalg/src/id_dist/src/idd_svd_subr_0.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/linalg/src/id_dist/src/idd_svd_subr_1.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/linalg/src/id_dist/src/idd_svd_subr_2.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/linalg/src/id_dist/src/prini.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran scipy/linalg/src/id_dist/src/prini.f:147:20: scipy/linalg/src/id_dist/src/prini.f:145:72: do 1800 i=1,1000 2 scipy/linalg/src/id_dist/src/prini.f:147:20: c(iadd+i)=b(i) 1 Warning: Array reference at (1) out of bounds (1000 > 1) in loop beginning at (2) gfortran:f77: scipy/linalg/src/id_dist/src/idz_snorm.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran scipy/linalg/src/id_dist/src/idz_snorm.f:166:18: enorm = enorm+v(k)*conjg(v(k)) 1 Warning: Possible change of value in conversion from COMPLEX(8) to REAL(8) at (1) [-Wconversion] gfortran:f77: scipy/linalg/src/id_dist/src/idz_id.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran scipy/linalg/src/id_dist/src/idz_id.f:107:20: iswap = rnorms(k) 1 Warning: Possible change of value in conversion from REAL(8) to INTEGER(4) at (1) [-Wconversion] scipy/linalg/src/id_dist/src/idz_id.f:115:20: list(k) = rnorms(k) 1 Warning: Possible change of value in conversion from REAL(8) to INTEGER(4) at (1) [-Wconversion] scipy/linalg/src/id_dist/src/idz_id.f:124:24: rnorms(k) = a(k,k) 1 Warning: Possible change of value in conversion from COMPLEX(8) to REAL(8) at (1) [-Wconversion] scipy/linalg/src/id_dist/src/idz_id.f:373:21: rnumer = a(j,krank+k)*conjg(a(j,krank+k)) 1 Warning: Possible change of value in conversion from COMPLEX(8) to REAL(8) at (1) [-Wconversion] scipy/linalg/src/id_dist/src/idz_id.f:374:21: rdenom = a(j,j)*conjg(a(j,j)) 1 Warning: Possible change of value in conversion from COMPLEX(8) to REAL(8) at (1) [-Wconversion] scipy/linalg/src/id_dist/src/idz_id.f:220:20: iswap = rnorms(k) 1 Warning: Possible change of value in conversion from REAL(8) to INTEGER(4) at (1) [-Wconversion] scipy/linalg/src/id_dist/src/idz_id.f:228:20: list(k) = rnorms(k) 1 Warning: Possible change of value in conversion from REAL(8) to INTEGER(4) at (1) [-Wconversion] scipy/linalg/src/id_dist/src/idz_id.f:237:22: rnorms(k) = a(k,k) 1 Warning: Possible change of value in conversion from COMPLEX(8) to REAL(8) at (1) [-Wconversion] gfortran:f77: scipy/linalg/src/id_dist/src/idz_house.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran scipy/linalg/src/id_dist/src/idz_house.f:73:18: sum = sum+vn(k)*conjg(vn(k)) 1 Warning: Possible change of value in conversion from COMPLEX(8) to REAL(8) at (1) [-Wconversion] scipy/linalg/src/id_dist/src/idz_house.f:169:16: sum = sum+x(k)*conjg(x(k)) 1 Warning: Possible change of value in conversion from COMPLEX(8) to REAL(8) at (1) [-Wconversion] scipy/linalg/src/id_dist/src/idz_house.f:189:14: rss = x1*conjg(x1) + sum 1 Warning: Possible change of value in conversion from COMPLEX(8) to REAL(8) at (1) [-Wconversion] scipy/linalg/src/id_dist/src/idz_house.f:199:15: test = conjg(phase) * x1 1 Warning: Possible change of value in conversion from COMPLEX(8) to REAL(8) at (1) [-Wconversion] scipy/linalg/src/id_dist/src/idz_house.f:234:15: scal = 2*v1*conjg(v1) / (v1*conjg(v1)+sum) 1 Warning: Possible change of value in conversion from COMPLEX(8) to REAL(8) at (1) [-Wconversion] scipy/linalg/src/id_dist/src/idz_house.f:237:14: rss = phase*rss 1 Warning: Possible change of value in conversion from COMPLEX(8) to REAL(8) at (1) [-Wconversion] gfortran:f77: scipy/linalg/src/id_dist/src/iddr_rid.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/linalg/src/id_dist/src/id_rand_subr_0.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/linalg/src/id_dist/src/id_rand_subr_1.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/linalg/src/id_dist/src/id_rand_subr_2.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran scipy/linalg/src/id_dist/src/id_rand_subr_2.f:31:14: j = m*r+1 1 Warning: Possible change of value in conversion from REAL(8) to INTEGER(4) at (1) [-Wconversion] gfortran:f77: scipy/linalg/src/id_dist/src/iddp_rsvd_subr_0.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/linalg/src/id_dist/src/iddp_rsvd_subr_1.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran scipy/linalg/src/id_dist/src/iddp_rsvd_subr_1.f:1:41: subroutine iddp_rsvd0(m,n,matvect,p1t,p2t,p3t,p4t, 1 Warning: Unused dummy argument 'matvect' at (1) [-Wunused-dummy-argument] scipy/linalg/src/id_dist/src/iddp_rsvd_subr_1.f:1:45: subroutine iddp_rsvd0(m,n,matvect,p1t,p2t,p3t,p4t, 1 Warning: Unused dummy argument 'p1t' at (1) [-Wunused-dummy-argument] scipy/linalg/src/id_dist/src/iddp_rsvd_subr_1.f:1:49: subroutine iddp_rsvd0(m,n,matvect,p1t,p2t,p3t,p4t, 1 Warning: Unused dummy argument 'p2t' at (1) [-Wunused-dummy-argument] scipy/linalg/src/id_dist/src/iddp_rsvd_subr_1.f:1:53: subroutine iddp_rsvd0(m,n,matvect,p1t,p2t,p3t,p4t, 1 Warning: Unused dummy argument 'p3t' at (1) [-Wunused-dummy-argument] scipy/linalg/src/id_dist/src/iddp_rsvd_subr_1.f:1:57: subroutine iddp_rsvd0(m,n,matvect,p1t,p2t,p3t,p4t, 1 Warning: Unused dummy argument 'p4t' at (1) [-Wunused-dummy-argument] gfortran:f77: scipy/linalg/src/id_dist/src/idz_id2svd_subr_0.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/linalg/src/id_dist/src/idz_id2svd_subr_1.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/linalg/src/id_dist/src/idz_id2svd_subr_2.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/linalg/src/id_dist/src/idzp_asvd_subr_0.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/linalg/src/id_dist/src/idzp_asvd_subr_1.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/linalg/src/id_dist/src/idzp_asvd_subr_2.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/linalg/src/id_dist/src/iddp_aid.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran scipy/linalg/src/id_dist/src/iddp_aid.f:78:13: n2 = work(2) 1 Warning: Possible change of value in conversion from REAL(8) to INTEGER(4) at (1) [-Wconversion] scipy/linalg/src/id_dist/src/iddp_aid.f:239:13: n2 = w(2) 1 Warning: Possible change of value in conversion from REAL(8) to INTEGER(4) at (1) [-Wconversion] gfortran:f77: scipy/linalg/src/id_dist/src/idd_id2svd_subr_0.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/linalg/src/id_dist/src/idd_id2svd_subr_1.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/linalg/src/id_dist/src/idd_id2svd_subr_2.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/linalg/src/id_dist/src/idzp_aid_subr_0.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran scipy/linalg/src/id_dist/src/idzp_aid_subr_0.f:63:13: n2 = work(2) 1 Warning: Possible change of value in conversion from COMPLEX(8) to INTEGER(4) at (1) [-Wconversion] gfortran:f77: scipy/linalg/src/id_dist/src/idzp_aid_subr_1.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/linalg/src/id_dist/src/idzp_aid_subr_2.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/linalg/src/id_dist/src/idzp_aid_subr_3.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran scipy/linalg/src/id_dist/src/idzp_aid_subr_3.f:47:13: n2 = w(2) 1 Warning: Possible change of value in conversion from COMPLEX(8) to INTEGER(4) at (1) [-Wconversion] gfortran:f77: scipy/linalg/src/id_dist/src/idzp_aid_subr_4.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran scipy/linalg/src/id_dist/src/idzp_aid_subr_4.f:29:17: ss = ss+a(j,k)*conjg(a(j,k)) 1 Warning: Possible change of value in conversion from COMPLEX(8) to REAL(8) at (1) [-Wconversion] gfortran:f77: scipy/linalg/src/id_dist/src/idzp_aid_subr_5.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran /usr/bin/gfortran -Wall -g -Wl,-z,relro -Wl,-z,now -specs=/usr/lib/rpm/redhat/redhat-hardened-ld -shared build/temp.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/linalg/_interpolativemodule.o build/temp.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/linalg/fortranobject.o build/temp.linux-ppc64le-2.7/scipy/linalg/src/id_dist/src/idz_svd_subr_0.o build/temp.linux-ppc64le-2.7/scipy/linalg/src/id_dist/src/idz_svd_subr_1.o build/temp.linux-ppc64le-2.7/scipy/linalg/src/id_dist/src/idz_svd_subr_2.o build/temp.linux-ppc64le-2.7/scipy/linalg/src/id_dist/src/idz_svd_subr_3.o build/temp.linux-ppc64le-2.7/scipy/linalg/src/id_dist/src/idz_qrpiv.o build/temp.linux-ppc64le-2.7/scipy/linalg/src/id_dist/src/idzp_rsvd_subr_0.o build/temp.linux-ppc64le-2.7/scipy/linalg/src/id_dist/src/idzp_rsvd_subr_1.o build/temp.linux-ppc64le-2.7/scipy/linalg/src/id_dist/src/idzp_rsvd_subr_2.o build/temp.linux-ppc64le-2.7/scipy/linalg/src/id_dist/src/idzr_rid.o build/temp.linux-ppc64le-2.7/scipy/linalg/src/id_dist/src/iddr_asvd_subr_0.o build/temp.linux-ppc64le-2.7/scipy/linalg/src/id_dist/src/iddr_asvd_subr_1.o build/temp.linux-ppc64le-2.7/scipy/linalg/src/id_dist/src/idzr_asvd_subr_0.o build/temp.linux-ppc64le-2.7/scipy/linalg/src/id_dist/src/idzr_asvd_subr_1.o build/temp.linux-ppc64le-2.7/scipy/linalg/src/id_dist/src/iddr_rsvd_subr_0.o build/temp.linux-ppc64le-2.7/scipy/linalg/src/id_dist/src/iddr_rsvd_subr_1.o build/temp.linux-ppc64le-2.7/scipy/linalg/src/id_dist/src/idd_id.o build/temp.linux-ppc64le-2.7/scipy/linalg/src/id_dist/src/idd_qrpiv.o build/temp.linux-ppc64le-2.7/scipy/linalg/src/id_dist/src/idz_sfft.o build/temp.linux-ppc64le-2.7/scipy/linalg/src/id_dist/src/idzr_rsvd_subr_0.o build/temp.linux-ppc64le-2.7/scipy/linalg/src/id_dist/src/idzr_rsvd_subr_1.o build/temp.linux-ppc64le-2.7/scipy/linalg/src/id_dist/src/id_rtrans_subr_0.o build/temp.linux-ppc64le-2.7/scipy/linalg/src/id_dist/src/id_rtrans_subr_1.o build/temp.linux-ppc64le-2.7/scipy/linalg/src/id_dist/src/id_rtrans_subr_2.o build/temp.linux-ppc64le-2.7/scipy/linalg/src/id_dist/src/id_rtrans_subr_3.o build/temp.linux-ppc64le-2.7/scipy/linalg/src/id_dist/src/id_rtrans_subr_4.o build/temp.linux-ppc64le-2.7/scipy/linalg/src/id_dist/src/id_rtrans_subr_5.o build/temp.linux-ppc64le-2.7/scipy/linalg/src/id_dist/src/id_rtrans_subr_6.o build/temp.linux-ppc64le-2.7/scipy/linalg/src/id_dist/src/id_rtrans_subr_7.o build/temp.linux-ppc64le-2.7/scipy/linalg/src/id_dist/src/id_rtrans_subr_8.o build/temp.linux-ppc64le-2.7/scipy/linalg/src/id_dist/src/id_rtrans_subr_9.o build/temp.linux-ppc64le-2.7/scipy/linalg/src/id_dist/src/id_rtrans_subr_10.o build/temp.linux-ppc64le-2.7/scipy/linalg/src/id_dist/src/id_rtrans_subr_11.o build/temp.linux-ppc64le-2.7/scipy/linalg/src/id_dist/src/iddp_asvd_subr_0.o build/temp.linux-ppc64le-2.7/scipy/linalg/src/id_dist/src/iddp_asvd_subr_1.o build/temp.linux-ppc64le-2.7/scipy/linalg/src/id_dist/src/idd_frm_subr_0.o build/temp.linux-ppc64le-2.7/scipy/linalg/src/id_dist/src/idd_frm_subr_1.o build/temp.linux-ppc64le-2.7/scipy/linalg/src/id_dist/src/idd_frm_subr_2.o build/temp.linux-ppc64le-2.7/scipy/linalg/src/id_dist/src/idd_frm_subr_3.o build/temp.linux-ppc64le-2.7/scipy/linalg/src/id_dist/src/idd_frm_subr_4.o build/temp.linux-ppc64le-2.7/scipy/linalg/src/id_dist/src/idd_frm_subr_5.o build/temp.linux-ppc64le-2.7/scipy/linalg/src/id_dist/src/idd_frm_subr_6.o build/temp.linux-ppc64le-2.7/scipy/linalg/src/id_dist/src/dfft_subr_0.o build/temp.linux-ppc64le-2.7/scipy/linalg/src/id_dist/src/dfft_subr_1.o build/temp.linux-ppc64le-2.7/scipy/linalg/src/id_dist/src/dfft_subr_2.o build/temp.linux-ppc64le-2.7/scipy/linalg/src/id_dist/src/dfft_subr_3.o build/temp.linux-ppc64le-2.7/scipy/linalg/src/id_dist/src/dfft_subr_4.o build/temp.linux-ppc64le-2.7/scipy/linalg/src/id_dist/src/dfft_subr_5.o build/temp.linux-ppc64le-2.7/scipy/linalg/src/id_dist/src/dfft_subr_6.o build/temp.linux-ppc64le-2.7/scipy/linalg/src/id_dist/src/dfft_subr_7.o build/temp.linux-ppc64le-2.7/scipy/linalg/src/id_dist/src/dfft_subr_8.o build/temp.linux-ppc64le-2.7/scipy/linalg/src/id_dist/src/dfft_subr_9.o build/temp.linux-ppc64le-2.7/scipy/linalg/src/id_dist/src/dfft_subr_10.o build/temp.linux-ppc64le-2.7/scipy/linalg/src/id_dist/src/dfft_subr_11.o build/temp.linux-ppc64le-2.7/scipy/linalg/src/id_dist/src/dfft_subr_12.o build/temp.linux-ppc64le-2.7/scipy/linalg/src/id_dist/src/dfft_subr_13.o build/temp.linux-ppc64le-2.7/scipy/linalg/src/id_dist/src/dfft_subr_14.o build/temp.linux-ppc64le-2.7/scipy/linalg/src/id_dist/src/dfft_subr_15.o build/temp.linux-ppc64le-2.7/scipy/linalg/src/id_dist/src/iddp_rid.o build/temp.linux-ppc64le-2.7/scipy/linalg/src/id_dist/src/idzr_aid.o build/temp.linux-ppc64le-2.7/scipy/linalg/src/id_dist/src/idz_frm_subr_0.o build/temp.linux-ppc64le-2.7/scipy/linalg/src/id_dist/src/idz_frm_subr_1.o build/temp.linux-ppc64le-2.7/scipy/linalg/src/id_dist/src/idz_frm_subr_2.o build/temp.linux-ppc64le-2.7/scipy/linalg/src/id_dist/src/idz_frm_subr_3.o build/temp.linux-ppc64le-2.7/scipy/linalg/src/id_dist/src/idd_house.o build/temp.linux-ppc64le-2.7/scipy/linalg/src/id_dist/src/idzp_rid.o build/temp.linux-ppc64le-2.7/scipy/linalg/src/id_dist/src/idd_sfft.o build/temp.linux-ppc64le-2.7/scipy/linalg/src/id_dist/src/iddr_aid.o build/temp.linux-ppc64le-2.7/scipy/linalg/src/id_dist/src/idd_snorm.o build/temp.linux-ppc64le-2.7/scipy/linalg/src/id_dist/src/idd_svd_subr_0.o build/temp.linux-ppc64le-2.7/scipy/linalg/src/id_dist/src/idd_svd_subr_1.o build/temp.linux-ppc64le-2.7/scipy/linalg/src/id_dist/src/idd_svd_subr_2.o build/temp.linux-ppc64le-2.7/scipy/linalg/src/id_dist/src/prini.o build/temp.linux-ppc64le-2.7/scipy/linalg/src/id_dist/src/idz_snorm.o build/temp.linux-ppc64le-2.7/scipy/linalg/src/id_dist/src/idz_id.o build/temp.linux-ppc64le-2.7/scipy/linalg/src/id_dist/src/idz_house.o build/temp.linux-ppc64le-2.7/scipy/linalg/src/id_dist/src/iddr_rid.o build/temp.linux-ppc64le-2.7/scipy/linalg/src/id_dist/src/id_rand_subr_0.o build/temp.linux-ppc64le-2.7/scipy/linalg/src/id_dist/src/id_rand_subr_1.o build/temp.linux-ppc64le-2.7/scipy/linalg/src/id_dist/src/id_rand_subr_2.o build/temp.linux-ppc64le-2.7/scipy/linalg/src/id_dist/src/iddp_rsvd_subr_0.o build/temp.linux-ppc64le-2.7/scipy/linalg/src/id_dist/src/iddp_rsvd_subr_1.o build/temp.linux-ppc64le-2.7/scipy/linalg/src/id_dist/src/idz_id2svd_subr_0.o build/temp.linux-ppc64le-2.7/scipy/linalg/src/id_dist/src/idz_id2svd_subr_1.o build/temp.linux-ppc64le-2.7/scipy/linalg/src/id_dist/src/idz_id2svd_subr_2.o build/temp.linux-ppc64le-2.7/scipy/linalg/src/id_dist/src/idzp_asvd_subr_0.o build/temp.linux-ppc64le-2.7/scipy/linalg/src/id_dist/src/idzp_asvd_subr_1.o build/temp.linux-ppc64le-2.7/scipy/linalg/src/id_dist/src/idzp_asvd_subr_2.o build/temp.linux-ppc64le-2.7/scipy/linalg/src/id_dist/src/iddp_aid.o build/temp.linux-ppc64le-2.7/scipy/linalg/src/id_dist/src/idd_id2svd_subr_0.o build/temp.linux-ppc64le-2.7/scipy/linalg/src/id_dist/src/idd_id2svd_subr_1.o build/temp.linux-ppc64le-2.7/scipy/linalg/src/id_dist/src/idd_id2svd_subr_2.o build/temp.linux-ppc64le-2.7/scipy/linalg/src/id_dist/src/idzp_aid_subr_0.o build/temp.linux-ppc64le-2.7/scipy/linalg/src/id_dist/src/idzp_aid_subr_1.o build/temp.linux-ppc64le-2.7/scipy/linalg/src/id_dist/src/idzp_aid_subr_2.o build/temp.linux-ppc64le-2.7/scipy/linalg/src/id_dist/src/idzp_aid_subr_3.o build/temp.linux-ppc64le-2.7/scipy/linalg/src/id_dist/src/idzp_aid_subr_4.o build/temp.linux-ppc64le-2.7/scipy/linalg/src/id_dist/src/idzp_aid_subr_5.o -L/usr/lib64 -L/usr/lib/gcc/ppc64le-redhat-linux/8 -L/usr/lib/gcc/ppc64le-redhat-linux/8 -L/usr/lib64 -Lbuild/temp.linux-ppc64le-2.7 -Wl,-rpath="/usr/lib64" -lopenblasp -lopenblas -lpython2.7 -lgfortran -o build/lib.linux-ppc64le-2.7/scipy/linalg/_interpolative.so building 'scipy.linalg._solve_toeplitz' extension compiling C sources C compiler: gcc -pthread -fno-strict-aliasing -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -D_GNU_SOURCE -fPIC -fwrapv -DNDEBUG -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -D_GNU_SOURCE -fPIC -fwrapv -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -fPIC compile options: '-I/usr/lib64/python2.7/site-packages/numpy/core/include -I/usr/lib64/python2.7/site-packages/numpy/core/include -I/usr/include/python2.7 -c' gcc: scipy/linalg/_solve_toeplitz.c In file included from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/ndarraytypes.h:1816, from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/ndarrayobject.h:18, from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/arrayobject.h:4, from scipy/linalg/_solve_toeplitz.c:435: /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/npy_1_7_deprecated_api.h:15:2: warning: #warning "Using deprecated NumPy API, disable it by " "#defining NPY_NO_DEPRECATED_API NPY_1_7_API_VERSION" [-Wcpp] #warning "Using deprecated NumPy API, disable it by " \ ^~~~~~~ gcc -pthread -shared -Wl,-z,relro -Wl,-z,now -specs=/usr/lib/rpm/redhat/redhat-hardened-ld -Wl,-z,relro -Wl,-z,now -specs=/usr/lib/rpm/redhat/redhat-hardened-ld -shared -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection build/temp.linux-ppc64le-2.7/scipy/linalg/_solve_toeplitz.o -L/usr/lib64 -Lbuild/temp.linux-ppc64le-2.7 -lpython2.7 -o build/lib.linux-ppc64le-2.7/scipy/linalg/_solve_toeplitz.so building 'scipy.linalg.cython_blas' extension compiling C sources C compiler: gcc -pthread -fno-strict-aliasing -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -D_GNU_SOURCE -fPIC -fwrapv -DNDEBUG -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -D_GNU_SOURCE -fPIC -fwrapv -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -fPIC compile options: '-DHAVE_CBLAS -Iscipy/linalg -I/usr/lib64/python2.7/site-packages/numpy/core/include -I/usr/include/python2.7 -c' gcc: scipy/linalg/cython_blas.c In file included from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/ndarraytypes.h:1816, from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/ndarrayobject.h:18, from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/arrayobject.h:4, from scipy/linalg/cython_blas.c:436: /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/npy_1_7_deprecated_api.h:15:2: warning: #warning "Using deprecated NumPy API, disable it by " "#defining NPY_NO_DEPRECATED_API NPY_1_7_API_VERSION" [-Wcpp] #warning "Using deprecated NumPy API, disable it by " \ ^~~~~~~ scipy/linalg/cython_blas.c: In function '__pyx_f_5scipy_6linalg_11cython_blas_cdotc': scipy/linalg/cython_blas.c:2220:31: warning: passing argument 1 of 'cdotcwrp_' from incompatible pointer type [-Wincompatible-pointer-types] F_FUNC(cdotcwrp, CDOTCWRP)((&__pyx_v_out), __pyx_v_n, ((npy_complex64 *)__pyx_v_cx), __pyx_v_incx, ((npy_complex64 *)__pyx_v_cy), __pyx_v_incy); ~^~~~~~~~~~~~~ In file included from scipy/linalg/cython_blas.c:438: scipy/linalg/_blas_subroutines.h:13:48: note: expected 'npy_complex64 *' {aka 'struct *'} but argument is of type '__pyx_t_float_complex *' {aka 'struct *'} void F_FUNC(cdotcwrp, CDOTCWRP)(npy_complex64 *ret, int *n, npy_complex64 *cx, int *incx, npy_complex64 *cy, int *incy); ~~~~~~~~~~~~~~~^~~ scipy/linalg/cython_blas.c: In function '__pyx_f_5scipy_6linalg_11cython_blas_cdotu': scipy/linalg/cython_blas.c:2264:31: warning: passing argument 1 of 'cdotuwrp_' from incompatible pointer type [-Wincompatible-pointer-types] F_FUNC(cdotuwrp, CDOTUWRP)((&__pyx_v_out), __pyx_v_n, ((npy_complex64 *)__pyx_v_cx), __pyx_v_incx, ((npy_complex64 *)__pyx_v_cy), __pyx_v_incy); ~^~~~~~~~~~~~~ In file included from scipy/linalg/cython_blas.c:438: scipy/linalg/_blas_subroutines.h:14:48: note: expected 'npy_complex64 *' {aka 'struct *'} but argument is of type '__pyx_t_float_complex *' {aka 'struct *'} void F_FUNC(cdotuwrp, CDOTUWRP)(npy_complex64 *ret, int *n, npy_complex64 *cx, int *incx, npy_complex64 *cy, int *incy); ~~~~~~~~~~~~~~~^~~ scipy/linalg/cython_blas.c: In function '__pyx_f_5scipy_6linalg_11cython_blas_zdotc': scipy/linalg/cython_blas.c:3100:31: warning: passing argument 1 of 'zdotcwrp_' from incompatible pointer type [-Wincompatible-pointer-types] F_FUNC(zdotcwrp, ZDOTCWRP)((&__pyx_v_out), __pyx_v_n, ((npy_complex128 *)__pyx_v_zx), __pyx_v_incx, ((npy_complex128 *)__pyx_v_zy), __pyx_v_incy); ~^~~~~~~~~~~~~ In file included from scipy/linalg/cython_blas.c:438: scipy/linalg/_blas_subroutines.h:33:49: note: expected 'npy_complex128 *' {aka 'struct *'} but argument is of type '__pyx_t_double_complex *' {aka 'struct *'} void F_FUNC(zdotcwrp, ZDOTCWRP)(npy_complex128 *ret, int *n, npy_complex128 *zx, int *incx, npy_complex128 *zy, int *incy); ~~~~~~~~~~~~~~~~^~~ scipy/linalg/cython_blas.c: In function '__pyx_f_5scipy_6linalg_11cython_blas_zdotu': scipy/linalg/cython_blas.c:3144:31: warning: passing argument 1 of 'zdotuwrp_' from incompatible pointer type [-Wincompatible-pointer-types] F_FUNC(zdotuwrp, ZDOTUWRP)((&__pyx_v_out), __pyx_v_n, ((npy_complex128 *)__pyx_v_zx), __pyx_v_incx, ((npy_complex128 *)__pyx_v_zy), __pyx_v_incy); ~^~~~~~~~~~~~~ In file included from scipy/linalg/cython_blas.c:438: scipy/linalg/_blas_subroutines.h:34:49: note: expected 'npy_complex128 *' {aka 'struct *'} but argument is of type '__pyx_t_double_complex *' {aka 'struct *'} void F_FUNC(zdotuwrp, ZDOTUWRP)(npy_complex128 *ret, int *n, npy_complex128 *zx, int *incx, npy_complex128 *zy, int *incy); ~~~~~~~~~~~~~~~~^~~ /usr/bin/gfortran -Wall -g -Wl,-z,relro -Wl,-z,now -specs=/usr/lib/rpm/redhat/redhat-hardened-ld -shared build/temp.linux-ppc64le-2.7/scipy/linalg/cython_blas.o -L/usr/lib64 -L/usr/lib/gcc/ppc64le-redhat-linux/8 -L/usr/lib/gcc/ppc64le-redhat-linux/8 -L/usr/lib64 -Lbuild/temp.linux-ppc64le-2.7 -Wl,-rpath="/usr/lib64" -lfwrappers -lopenblasp -lopenblas -lpython2.7 -lgfortran -o build/lib.linux-ppc64le-2.7/scipy/linalg/cython_blas.so building 'scipy.linalg.cython_lapack' extension compiling C sources C compiler: gcc -pthread -fno-strict-aliasing -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -D_GNU_SOURCE -fPIC -fwrapv -DNDEBUG -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -D_GNU_SOURCE -fPIC -fwrapv -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -fPIC compile options: '-DHAVE_CBLAS -Iscipy/linalg -I/usr/lib64/python2.7/site-packages/numpy/core/include -I/usr/include/python2.7 -c' gcc: scipy/linalg/cython_lapack.c In file included from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/ndarraytypes.h:1816, from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/ndarrayobject.h:18, from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/arrayobject.h:4, from scipy/linalg/cython_lapack.c:436: /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/npy_1_7_deprecated_api.h:15:2: warning: #warning "Using deprecated NumPy API, disable it by " "#defining NPY_NO_DEPRECATED_API NPY_1_7_API_VERSION" [-Wcpp] #warning "Using deprecated NumPy API, disable it by " \ ^~~~~~~ scipy/linalg/cython_lapack.c: In function '__pyx_f_5scipy_6linalg_13cython_lapack_cladiv': scipy/linalg/cython_lapack.c:1456:33: warning: passing argument 1 of 'cladivwrp_' from incompatible pointer type [-Wincompatible-pointer-types] F_FUNC(cladivwrp, CLADIVWRP)((&__pyx_v_out), ((npy_complex64 *)__pyx_v_x), ((npy_complex64 *)__pyx_v_y)); ~^~~~~~~~~~~~~ In file included from scipy/linalg/cython_lapack.c:438: scipy/linalg/_lapack_subroutines.h:22:50: note: expected 'npy_complex64 *' {aka 'struct *'} but argument is of type '__pyx_t_float_complex *' {aka 'struct *'} void F_FUNC(cladivwrp, CLADIVWRP)(npy_complex64 *ret, npy_complex64 *x, npy_complex64 *y); ~~~~~~~~~~~~~~~^~~ scipy/linalg/cython_lapack.c: In function '__pyx_f_5scipy_6linalg_13cython_lapack_zladiv': scipy/linalg/cython_lapack.c:3656:33: warning: passing argument 1 of 'zladivwrp_' from incompatible pointer type [-Wincompatible-pointer-types] F_FUNC(zladivwrp, ZLADIVWRP)((&__pyx_v_out), ((npy_complex128 *)__pyx_v_x), ((npy_complex128 *)__pyx_v_y)); ~^~~~~~~~~~~~~ In file included from scipy/linalg/cython_lapack.c:438: scipy/linalg/_lapack_subroutines.h:72:51: note: expected 'npy_complex128 *' {aka 'struct *'} but argument is of type '__pyx_t_double_complex *' {aka 'struct *'} void F_FUNC(zladivwrp, ZLADIVWRP)(npy_complex128 *ret, npy_complex128 *x, npy_complex128 *y); ~~~~~~~~~~~~~~~~^~~ /usr/bin/gfortran -Wall -g -Wl,-z,relro -Wl,-z,now -specs=/usr/lib/rpm/redhat/redhat-hardened-ld -shared build/temp.linux-ppc64le-2.7/scipy/linalg/cython_lapack.o -L/usr/lib64 -L/usr/lib/gcc/ppc64le-redhat-linux/8 -L/usr/lib/gcc/ppc64le-redhat-linux/8 -L/usr/lib64 -Lbuild/temp.linux-ppc64le-2.7 -Wl,-rpath="/usr/lib64" -lfwrappers -lopenblasp -lopenblas -lpython2.7 -lgfortran -o build/lib.linux-ppc64le-2.7/scipy/linalg/cython_lapack.so building 'scipy.linalg._decomp_update' extension compiling C sources C compiler: gcc -pthread -fno-strict-aliasing -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -D_GNU_SOURCE -fPIC -fwrapv -DNDEBUG -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -D_GNU_SOURCE -fPIC -fwrapv -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -fPIC compile options: '-I/usr/lib64/python2.7/site-packages/numpy/core/include -I/usr/include/python2.7 -c' gcc: scipy/linalg/_decomp_update.c In file included from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/ndarraytypes.h:1816, from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/ndarrayobject.h:18, from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/arrayobject.h:4, from scipy/linalg/_decomp_update.c:438: /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/npy_1_7_deprecated_api.h:15:2: warning: #warning "Using deprecated NumPy API, disable it by " "#defining NPY_NO_DEPRECATED_API NPY_1_7_API_VERSION" [-Wcpp] #warning "Using deprecated NumPy API, disable it by " \ ^~~~~~~ gcc -pthread -shared -Wl,-z,relro -Wl,-z,now -specs=/usr/lib/rpm/redhat/redhat-hardened-ld -Wl,-z,relro -Wl,-z,now -specs=/usr/lib/rpm/redhat/redhat-hardened-ld -shared -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection build/temp.linux-ppc64le-2.7/scipy/linalg/_decomp_update.o -L/usr/lib64 -Lbuild/temp.linux-ppc64le-2.7 -lpython2.7 -o build/lib.linux-ppc64le-2.7/scipy/linalg/_decomp_update.so building 'scipy.odr.__odrpack' extension compiling C sources C compiler: gcc -pthread -fno-strict-aliasing -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -D_GNU_SOURCE -fPIC -fwrapv -DNDEBUG -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -D_GNU_SOURCE -fPIC -fwrapv -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -fPIC compile options: '-DHAVE_CBLAS -Iscipy/odr -I/usr/lib64/python2.7/site-packages/numpy/core/include -I/usr/include/python2.7 -c' gcc: scipy/odr/__odrpack.c In file included from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/ndarraytypes.h:1816, from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/ndarrayobject.h:18, from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/arrayobject.h:4, from scipy/odr/odrpack.h:2, from scipy/odr/__odrpack.c:12: /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/npy_1_7_deprecated_api.h:15:2: warning: #warning "Using deprecated NumPy API, disable it by " "#defining NPY_NO_DEPRECATED_API NPY_1_7_API_VERSION" [-Wcpp] #warning "Using deprecated NumPy API, disable it by " \ ^~~~~~~ scipy/odr/__odrpack.c: In function 'odr': scipy/odr/__odrpack.c:1115:22: warning: format '%d' expects argument of type 'int', but argument 2 has type 'npy_intp' {aka 'long int'} [-Wformat=] printf("%d %d\n", work->dimensions[0], lwork); ~^ ~~~~~~~~~~~~~~~~~~~ %ld scipy/odr/__odrpack.c: In function 'init__odrpack': scipy/odr/__odrpack.c:1302:15: warning: variable 'm' set but not used [-Wunused-but-set-variable] PyObject *m; ^ In file included from /usr/include/python2.7/Python.h:83, from scipy/odr/odrpack.h:1, from scipy/odr/__odrpack.c:12: scipy/odr/__odrpack.c: In function 'fcn_callback': /usr/include/python2.7/object.h:773:12: warning: 'result' may be used uninitialized in this function [-Wmaybe-uninitialized] if (_Py_DEC_REFTOTAL _Py_REF_DEBUG_COMMA \ ^ scipy/odr/__odrpack.c:47:13: note: 'result' was declared here PyObject *result; ^~~~~~ /usr/bin/gfortran -Wall -g -Wl,-z,relro -Wl,-z,now -specs=/usr/lib/rpm/redhat/redhat-hardened-ld -shared build/temp.linux-ppc64le-2.7/scipy/odr/__odrpack.o -L/usr/lib64 -L/usr/lib/gcc/ppc64le-redhat-linux/8 -L/usr/lib/gcc/ppc64le-redhat-linux/8 -L/usr/lib64 -Lbuild/temp.linux-ppc64le-2.7 -Wl,-rpath="/usr/lib64" -lodrpack -lopenblasp -lopenblas -lpython2.7 -lgfortran -o build/lib.linux-ppc64le-2.7/scipy/odr/__odrpack.so building 'scipy.optimize._minpack' extension compiling C sources C compiler: gcc -pthread -fno-strict-aliasing -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -D_GNU_SOURCE -fPIC -fwrapv -DNDEBUG -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -D_GNU_SOURCE -fPIC -fwrapv -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -fPIC compile options: '-DNPY_NO_DEPRECATED_API=NPY_1_9_API_VERSION -I/usr/lib64/python2.7/site-packages/numpy/core/include -I/usr/include/python2.7 -c' gcc: scipy/optimize/_minpackmodule.c In file included from scipy/optimize/_minpackmodule.c:5: scipy/optimize/__minpack.h: In function 'minpack_hybrd': scipy/optimize/minpack.h:43:64: warning: unused variable 'store_multipack_globals3' [-Wunused-variable] #define STORE_VARS() PyObject *store_multipack_globals[4]; int store_multipack_globals3; ^~~~~~~~~~~~~~~~~~~~~~~~ scipy/optimize/__minpack.h:245:3: note: in expansion of macro 'STORE_VARS' STORE_VARS(); /* Define storage variables for global variables. */ ^~~~~~~~~~ scipy/optimize/__minpack.h: In function 'minpack_lmdif': scipy/optimize/minpack.h:43:64: warning: unused variable 'store_multipack_globals3' [-Wunused-variable] #define STORE_VARS() PyObject *store_multipack_globals[4]; int store_multipack_globals3; ^~~~~~~~~~~~~~~~~~~~~~~~ scipy/optimize/__minpack.h:452:3: note: in expansion of macro 'STORE_VARS' STORE_VARS(); ^~~~~~~~~~ /usr/bin/gfortran -Wall -g -Wl,-z,relro -Wl,-z,now -specs=/usr/lib/rpm/redhat/redhat-hardened-ld -shared build/temp.linux-ppc64le-2.7/scipy/optimize/_minpackmodule.o -L/usr/lib/gcc/ppc64le-redhat-linux/8 -L/usr/lib/gcc/ppc64le-redhat-linux/8 -L/usr/lib64 -Lbuild/temp.linux-ppc64le-2.7 -lminpack -lpython2.7 -lgfortran -o build/lib.linux-ppc64le-2.7/scipy/optimize/_minpack.so building 'scipy.optimize._zeros' extension compiling C sources C compiler: gcc -pthread -fno-strict-aliasing -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -D_GNU_SOURCE -fPIC -fwrapv -DNDEBUG -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -D_GNU_SOURCE -fPIC -fwrapv -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -fPIC compile options: '-DNPY_NO_DEPRECATED_API=NPY_1_9_API_VERSION -I/usr/lib64/python2.7/site-packages/numpy/core/include -I/usr/include/python2.7 -c' gcc: scipy/optimize/zeros.c gcc -pthread -shared -Wl,-z,relro -Wl,-z,now -specs=/usr/lib/rpm/redhat/redhat-hardened-ld -Wl,-z,relro -Wl,-z,now -specs=/usr/lib/rpm/redhat/redhat-hardened-ld -shared -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection build/temp.linux-ppc64le-2.7/scipy/optimize/zeros.o -L/usr/lib64 -Lbuild/temp.linux-ppc64le-2.7 -lrootfind -lpython2.7 -o build/lib.linux-ppc64le-2.7/scipy/optimize/_zeros.so building 'scipy.optimize._lbfgsb' extension compiling C sources C compiler: gcc -pthread -fno-strict-aliasing -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -D_GNU_SOURCE -fPIC -fwrapv -DNDEBUG -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -D_GNU_SOURCE -fPIC -fwrapv -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -fPIC creating build/temp.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/optimize creating build/temp.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/optimize/lbfgsb creating build/temp.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/optimize creating build/temp.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/optimize/lbfgsb compile options: '-DHAVE_CBLAS -DNPY_NO_DEPRECATED_API=NPY_1_9_API_VERSION -Ibuild/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/optimize/lbfgsb -I/usr/lib64/python2.7/site-packages/numpy/core/include -I/usr/include/python2.7 -c' gcc: build/src.linux-ppc64le-2.7/scipy/optimize/lbfgsb/_lbfgsbmodule.c build/src.linux-ppc64le-2.7/scipy/optimize/lbfgsb/_lbfgsbmodule.c:182:12: warning: 'f2py_size' defined but not used [-Wunused-function] static int f2py_size(PyArrayObject* var, ...) ^~~~~~~~~ gcc: build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/optimize/lbfgsb/fortranobject.c compiling Fortran sources Fortran f77 compiler: /usr/bin/gfortran -Wall -g -ffixed-form -fno-second-underscore -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -fPIC -cpp -O3 -funroll-loops Fortran f90 compiler: /usr/bin/gfortran -Wall -g -fno-second-underscore -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -fPIC -cpp -O3 -funroll-loops Fortran fix compiler: /usr/bin/gfortran -Wall -g -ffixed-form -fno-second-underscore -Wall -g -fno-second-underscore -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -fPIC -cpp -O3 -funroll-loops creating build/temp.linux-ppc64le-2.7/scipy/optimize/lbfgsb compile options: '-DHAVE_CBLAS -DNPY_NO_DEPRECATED_API=NPY_1_9_API_VERSION -Ibuild/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/optimize/lbfgsb -I/usr/lib64/python2.7/site-packages/numpy/core/include -I/usr/include/python2.7 -c' gfortran:f77: scipy/optimize/lbfgsb/lbfgsb.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran scipy/optimize/lbfgsb/lbfgsb.f:969:5: 1003 format (2(1x,i4),5x,'-',5x,'-',3x,'-',5x,'-',5x,'-',8x,'-',3x, 1 Warning: Label 1003 at (1) defined but not used [-Wunused-label] scipy/optimize/lbfgsb/lbfgsb.f:2860:5: 3002 format(2(1x,i4),2(1x,i5),2x,a3,1x,i4,1p,2(2x,d7.1),6x,'-',10x,'-') 1 Warning: Label 3002 at (1) defined but not used [-Wunused-label] scipy/optimize/lbfgsb/lbfgsb.f:2718:5: 9001 format (/,3x,'it',3x,'nf',2x,'nseg',2x,'nact',2x,'sub',2x,'itls', 1 Warning: Label 9001 at (1) defined but not used [-Wunused-label] scipy/optimize/lbfgsb/lbfgsb.f:2700:5: 2001 format ('RUNNING THE L-BFGS-B CODE',/,/, 1 Warning: Label 2001 at (1) defined but not used [-Wunused-label] scipy/optimize/lbfgsb/lbfgsb.f:2786:5: 3001 format(2(1x,i4),2(1x,i5),2x,a3,1x,i4,1p,2(2x,d7.1),1p,2(1x,d10.3)) 1 Warning: Label 3001 at (1) defined but not used [-Wunused-label] scipy/optimize/lbfgsb/lbfgsb.f:2796:47: + time, nseg, word, iback, stp, xstep, k, 1 Warning: Unused dummy argument 'iback' at (1) [-Wunused-dummy-argument] scipy/optimize/lbfgsb/lbfgsb.f:2796:34: + time, nseg, word, iback, stp, xstep, k, 1 Warning: Unused dummy argument 'nseg' at (1) [-Wunused-dummy-argument] scipy/optimize/lbfgsb/lbfgsb.f:2796:52: + time, nseg, word, iback, stp, xstep, k, 1 Warning: Unused dummy argument 'stp' at (1) [-Wunused-dummy-argument] scipy/optimize/lbfgsb/lbfgsb.f:2796:40: + time, nseg, word, iback, stp, xstep, k, 1 Warning: Unused dummy argument 'word' at (1) [-Wunused-dummy-argument] scipy/optimize/lbfgsb/lbfgsb.f:2796:59: + time, nseg, word, iback, stp, xstep, k, 1 Warning: Unused dummy argument 'xstep' at (1) [-Wunused-dummy-argument] scipy/optimize/lbfgsb/lbfgsb.f:2727:60: subroutine prn2lb(n, x, f, g, iprint, iter, nfgv, nact, 1 Warning: Unused dummy argument 'nact' at (1) [-Wunused-dummy-argument] scipy/optimize/lbfgsb/lbfgsb.f:2727:54: subroutine prn2lb(n, x, f, g, iprint, iter, nfgv, nact, 1 Warning: Unused dummy argument 'nfgv' at (1) [-Wunused-dummy-argument] scipy/optimize/lbfgsb/lbfgsb.f:2728:36: + sbgnrm, nseg, word, iword, iback, stp, xstep) 1 Warning: Unused dummy argument 'nseg' at (1) [-Wunused-dummy-argument] scipy/optimize/lbfgsb/lbfgsb.f:2728:61: + sbgnrm, nseg, word, iword, iback, stp, xstep) 1 Warning: Unused dummy argument 'stp' at (1) [-Wunused-dummy-argument] scipy/optimize/lbfgsb/lbfgsb.f:1400:0: + tu,tl,wmc,wmp,wmw,ddot,tj,tj0,neggi,sbgnrm, Warning: 'tu' may be used uninitialized in this function [-Wmaybe-uninitialized] scipy/optimize/lbfgsb/lbfgsb.f:1473:0: t(nbreak) = tl/(-neggi) Warning: 'tl' may be used uninitialized in this function [-Wmaybe-uninitialized] gfortran:f77: scipy/optimize/lbfgsb/linpack.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/optimize/lbfgsb/timer.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran scipy/optimize/lbfgsb/timer.f:4:15: real temp 1 Warning: Unused variable 'temp' declared at (1) [-Wunused-variable] /usr/bin/gfortran -Wall -g -Wl,-z,relro -Wl,-z,now -specs=/usr/lib/rpm/redhat/redhat-hardened-ld -shared build/temp.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/optimize/lbfgsb/_lbfgsbmodule.o build/temp.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/optimize/lbfgsb/fortranobject.o build/temp.linux-ppc64le-2.7/scipy/optimize/lbfgsb/lbfgsb.o build/temp.linux-ppc64le-2.7/scipy/optimize/lbfgsb/linpack.o build/temp.linux-ppc64le-2.7/scipy/optimize/lbfgsb/timer.o -L/usr/lib64 -L/usr/lib/gcc/ppc64le-redhat-linux/8 -L/usr/lib/gcc/ppc64le-redhat-linux/8 -L/usr/lib64 -Lbuild/temp.linux-ppc64le-2.7 -Wl,-rpath="/usr/lib64" -lopenblasp -lopenblas -lpython2.7 -lgfortran -o build/lib.linux-ppc64le-2.7/scipy/optimize/_lbfgsb.so building 'scipy.optimize.moduleTNC' extension compiling C sources C compiler: gcc -pthread -fno-strict-aliasing -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -D_GNU_SOURCE -fPIC -fwrapv -DNDEBUG -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -D_GNU_SOURCE -fPIC -fwrapv -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -fPIC creating build/temp.linux-ppc64le-2.7/scipy/optimize/tnc compile options: '-DNPY_NO_DEPRECATED_API=NPY_1_9_API_VERSION -I/usr/lib64/python2.7/site-packages/numpy/core/include -I/usr/include/python2.7 -c' gcc: scipy/optimize/tnc/moduleTNC.c scipy/optimize/tnc/moduleTNC.c:26:19: warning: 'rcsid' defined but not used [-Wunused-const-variable=] static char const rcsid[] = ^~~~~ gcc: scipy/optimize/tnc/tnc.c gcc -pthread -shared -Wl,-z,relro -Wl,-z,now -specs=/usr/lib/rpm/redhat/redhat-hardened-ld -Wl,-z,relro -Wl,-z,now -specs=/usr/lib/rpm/redhat/redhat-hardened-ld -shared -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection build/temp.linux-ppc64le-2.7/scipy/optimize/tnc/moduleTNC.o build/temp.linux-ppc64le-2.7/scipy/optimize/tnc/tnc.o -L/usr/lib64 -Lbuild/temp.linux-ppc64le-2.7 -lpython2.7 -o build/lib.linux-ppc64le-2.7/scipy/optimize/moduleTNC.so building 'scipy.optimize._cobyla' extension compiling C sources C compiler: gcc -pthread -fno-strict-aliasing -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -D_GNU_SOURCE -fPIC -fwrapv -DNDEBUG -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -D_GNU_SOURCE -fPIC -fwrapv -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -fPIC creating build/temp.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/optimize/cobyla creating build/temp.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/optimize/cobyla compile options: '-DNPY_NO_DEPRECATED_API=NPY_1_9_API_VERSION -Ibuild/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/optimize/cobyla -I/usr/lib64/python2.7/site-packages/numpy/core/include -I/usr/include/python2.7 -c' gcc: build/src.linux-ppc64le-2.7/scipy/optimize/cobyla/_cobylamodule.c build/src.linux-ppc64le-2.7/scipy/optimize/cobyla/_cobylamodule.c: In function 'cb_calcfc_in__cobyla__user__routines': build/src.linux-ppc64le-2.7/scipy/optimize/cobyla/_cobylamodule.c:354:10: warning: unused variable 'f' [-Wunused-variable] double f=(*f_cb_capi); ^ At top level: build/src.linux-ppc64le-2.7/scipy/optimize/cobyla/_cobylamodule.c:127:12: warning: 'f2py_size' defined but not used [-Wunused-function] static int f2py_size(PyArrayObject* var, ...) ^~~~~~~~~ gcc: build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/optimize/cobyla/fortranobject.c compiling Fortran sources Fortran f77 compiler: /usr/bin/gfortran -Wall -g -ffixed-form -fno-second-underscore -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -fPIC -cpp -O3 -funroll-loops Fortran f90 compiler: /usr/bin/gfortran -Wall -g -fno-second-underscore -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -fPIC -cpp -O3 -funroll-loops Fortran fix compiler: /usr/bin/gfortran -Wall -g -ffixed-form -fno-second-underscore -Wall -g -fno-second-underscore -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -fPIC -cpp -O3 -funroll-loops creating build/temp.linux-ppc64le-2.7/scipy/optimize/cobyla compile options: '-DNPY_NO_DEPRECATED_API=NPY_1_9_API_VERSION -Ibuild/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/optimize/cobyla -I/usr/lib64/python2.7/site-packages/numpy/core/include -I/usr/include/python2.7 -c' gfortran:f77: scipy/optimize/cobyla/cobyla2.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/optimize/cobyla/trstlp.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran /usr/bin/gfortran -Wall -g -Wl,-z,relro -Wl,-z,now -specs=/usr/lib/rpm/redhat/redhat-hardened-ld -shared build/temp.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/optimize/cobyla/_cobylamodule.o build/temp.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/optimize/cobyla/fortranobject.o build/temp.linux-ppc64le-2.7/scipy/optimize/cobyla/cobyla2.o build/temp.linux-ppc64le-2.7/scipy/optimize/cobyla/trstlp.o -L/usr/lib/gcc/ppc64le-redhat-linux/8 -L/usr/lib/gcc/ppc64le-redhat-linux/8 -L/usr/lib64 -Lbuild/temp.linux-ppc64le-2.7 -lpython2.7 -lgfortran -o build/lib.linux-ppc64le-2.7/scipy/optimize/_cobyla.so building 'scipy.optimize.minpack2' extension compiling C sources C compiler: gcc -pthread -fno-strict-aliasing -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -D_GNU_SOURCE -fPIC -fwrapv -DNDEBUG -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -D_GNU_SOURCE -fPIC -fwrapv -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -fPIC creating build/temp.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/optimize/minpack2 creating build/temp.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/optimize/minpack2 compile options: '-DNPY_NO_DEPRECATED_API=NPY_1_9_API_VERSION -Ibuild/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/optimize/minpack2 -I/usr/lib64/python2.7/site-packages/numpy/core/include -I/usr/include/python2.7 -c' gcc: build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/optimize/minpack2/fortranobject.c gcc: build/src.linux-ppc64le-2.7/scipy/optimize/minpack2/minpack2module.c build/src.linux-ppc64le-2.7/scipy/optimize/minpack2/minpack2module.c:134:12: warning: 'f2py_size' defined but not used [-Wunused-function] static int f2py_size(PyArrayObject* var, ...) ^~~~~~~~~ compiling Fortran sources Fortran f77 compiler: /usr/bin/gfortran -Wall -g -ffixed-form -fno-second-underscore -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -fPIC -cpp -O3 -funroll-loops Fortran f90 compiler: /usr/bin/gfortran -Wall -g -fno-second-underscore -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -fPIC -cpp -O3 -funroll-loops Fortran fix compiler: /usr/bin/gfortran -Wall -g -ffixed-form -fno-second-underscore -Wall -g -fno-second-underscore -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -fPIC -cpp -O3 -funroll-loops creating build/temp.linux-ppc64le-2.7/scipy/optimize/minpack2 compile options: '-DNPY_NO_DEPRECATED_API=NPY_1_9_API_VERSION -Ibuild/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/optimize/minpack2 -I/usr/lib64/python2.7/site-packages/numpy/core/include -I/usr/include/python2.7 -c' gfortran:f77: scipy/optimize/minpack2/dcsrch.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: scipy/optimize/minpack2/dcstep.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran /usr/bin/gfortran -Wall -g -Wl,-z,relro -Wl,-z,now -specs=/usr/lib/rpm/redhat/redhat-hardened-ld -shared build/temp.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/optimize/minpack2/minpack2module.o build/temp.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/optimize/minpack2/fortranobject.o build/temp.linux-ppc64le-2.7/scipy/optimize/minpack2/dcsrch.o build/temp.linux-ppc64le-2.7/scipy/optimize/minpack2/dcstep.o -L/usr/lib/gcc/ppc64le-redhat-linux/8 -L/usr/lib/gcc/ppc64le-redhat-linux/8 -L/usr/lib64 -Lbuild/temp.linux-ppc64le-2.7 -lpython2.7 -lgfortran -o build/lib.linux-ppc64le-2.7/scipy/optimize/minpack2.so building 'scipy.optimize._slsqp' extension compiling C sources C compiler: gcc -pthread -fno-strict-aliasing -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -D_GNU_SOURCE -fPIC -fwrapv -DNDEBUG -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -D_GNU_SOURCE -fPIC -fwrapv -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -fPIC creating build/temp.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/optimize/slsqp creating build/temp.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/optimize/slsqp compile options: '-DNPY_NO_DEPRECATED_API=NPY_1_9_API_VERSION -Ibuild/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/optimize/slsqp -I/usr/lib64/python2.7/site-packages/numpy/core/include -I/usr/include/python2.7 -c' gcc: build/src.linux-ppc64le-2.7/scipy/optimize/slsqp/_slsqpmodule.c build/src.linux-ppc64le-2.7/scipy/optimize/slsqp/_slsqpmodule.c:150:12: warning: 'f2py_size' defined but not used [-Wunused-function] static int f2py_size(PyArrayObject* var, ...) ^~~~~~~~~ gcc: build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/optimize/slsqp/fortranobject.c compiling Fortran sources Fortran f77 compiler: /usr/bin/gfortran -Wall -g -ffixed-form -fno-second-underscore -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -fPIC -cpp -O3 -funroll-loops Fortran f90 compiler: /usr/bin/gfortran -Wall -g -fno-second-underscore -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -fPIC -cpp -O3 -funroll-loops Fortran fix compiler: /usr/bin/gfortran -Wall -g -ffixed-form -fno-second-underscore -Wall -g -fno-second-underscore -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -fPIC -cpp -O3 -funroll-loops creating build/temp.linux-ppc64le-2.7/scipy/optimize/slsqp compile options: '-DNPY_NO_DEPRECATED_API=NPY_1_9_API_VERSION -Ibuild/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/optimize/slsqp -I/usr/lib64/python2.7/site-packages/numpy/core/include -I/usr/include/python2.7 -c' gfortran:f77: scipy/optimize/slsqp/slsqp_optmz.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran scipy/optimize/slsqp/slsqp_optmz.f:1958:72: 10 assign 30 to next 1 Warning: Deleted feature: ASSIGN statement at (1) scipy/optimize/slsqp/slsqp_optmz.f:1963:19: 20 GO TO next,(30, 50, 70, 110) 1 Warning: Deleted feature: Assigned GOTO statement at (1) scipy/optimize/slsqp/slsqp_optmz.f:1965:72: assign 50 to next 1 Warning: Deleted feature: ASSIGN statement at (1) scipy/optimize/slsqp/slsqp_optmz.f:1975:72: assign 70 to next 1 Warning: Deleted feature: ASSIGN statement at (1) scipy/optimize/slsqp/slsqp_optmz.f:1981:72: assign 110 to next 1 Warning: Deleted feature: ASSIGN statement at (1) scipy/optimize/slsqp/slsqp_optmz.f:1994:5: 110 IF( ABS(dx(i)) .LE. xmax ) GO TO 115 1 Warning: Label 110 at (1) defined but not used [-Wunused-label] scipy/optimize/slsqp/slsqp_optmz.f:1989:5: 70 IF( ABS(dx(i)) .GT. cutlo ) GO TO 75 1 Warning: Label 70 at (1) defined but not used [-Wunused-label] scipy/optimize/slsqp/slsqp_optmz.f:1970:5: 50 IF( dx(i) .EQ. ZERO) GO TO 200 1 Warning: Label 50 at (1) defined but not used [-Wunused-label] scipy/optimize/slsqp/slsqp_optmz.f:859:49: CALL hfti (w(ie),me,me,l,w(IF),k,1,t,krank,xnrm,w,w(l+1),jw) 1 Warning: Rank mismatch in argument 'rnorm' at (1) (rank-1 and scalar) [-Wargument-mismatch] scipy/optimize/slsqp/slsqp_optmz.f:600:54: INTEGER jw(*),i,ic,id,ie,IF,ig,ih,il,im,ip,iu,iw, 1 Warning: Unused variable 'im' declared at (1) [-Wunused-variable] scipy/optimize/slsqp/slsqp_optmz.f:600:60: INTEGER jw(*),i,ic,id,ie,IF,ig,ih,il,im,ip,iu,iw, 1 Warning: Unused variable 'iu' declared at (1) [-Wunused-variable] scipy/optimize/slsqp/slsqp_optmz.f:1544:0: alpha=tp/t Warning: 'tp' may be used uninitialized in this function [-Wmaybe-uninitialized] scipy/optimize/slsqp/slsqp_optmz.f:1995:0: sum = one + sum * (xmax / dx(i))**2 Warning: 'xmax' may be used uninitialized in this function [-Wmaybe-uninitialized] scipy/optimize/slsqp/slsqp_optmz.f:1639:0: 20 m = 0.5d0*(a + b) Warning: 'u' may be used uninitialized in this function [-Wmaybe-uninitialized] scipy/optimize/slsqp/slsqp_optmz.f:1640:0: tol1 = eps*ABS(x) + tol Warning: 'x' may be used uninitialized in this function [-Wmaybe-uninitialized] scipy/optimize/slsqp/slsqp_optmz.f:1649:0: IF (ABS(e) .LE. tol1) GOTO 30 Warning: 'e' may be used uninitialized in this function [-Wmaybe-uninitialized] scipy/optimize/slsqp/slsqp_optmz.f:1654:0: q = (x - v)*(fx - fw) Warning: 'w' may be used uninitialized in this function [-Wmaybe-uninitialized] scipy/optimize/slsqp/slsqp_optmz.f:1695:0: IF (fu .GT. fx) GOTO 60 Warning: 'fx' may be used uninitialized in this function [-Wmaybe-uninitialized] scipy/optimize/slsqp/slsqp_optmz.f:1707:0: IF (fu .LE. fw .OR. w .EQ. x) GOTO 70 Warning: 'fw' may be used uninitialized in this function [-Wmaybe-uninitialized] scipy/optimize/slsqp/slsqp_optmz.f:1708:0: IF (fu .LE. fv .OR. v .EQ. x .OR. v .EQ. w) GOTO 80 Warning: 'fv' may be used uninitialized in this function [-Wmaybe-uninitialized] scipy/optimize/slsqp/slsqp_optmz.f:1708:0: Warning: 'v' may be used uninitialized in this function [-Wmaybe-uninitialized] scipy/optimize/slsqp/slsqp_optmz.f:1167:0: j=INDEX(iz) Warning: 'izmax' may be used uninitialized in this function [-Wmaybe-uninitialized] /usr/bin/gfortran -Wall -g -Wl,-z,relro -Wl,-z,now -specs=/usr/lib/rpm/redhat/redhat-hardened-ld -shared build/temp.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/optimize/slsqp/_slsqpmodule.o build/temp.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/optimize/slsqp/fortranobject.o build/temp.linux-ppc64le-2.7/scipy/optimize/slsqp/slsqp_optmz.o -L/usr/lib/gcc/ppc64le-redhat-linux/8 -L/usr/lib/gcc/ppc64le-redhat-linux/8 -L/usr/lib64 -Lbuild/temp.linux-ppc64le-2.7 -lpython2.7 -lgfortran -o build/lib.linux-ppc64le-2.7/scipy/optimize/_slsqp.so building 'scipy.optimize._nnls' extension compiling C sources C compiler: gcc -pthread -fno-strict-aliasing -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -D_GNU_SOURCE -fPIC -fwrapv -DNDEBUG -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -D_GNU_SOURCE -fPIC -fwrapv -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -fPIC creating build/temp.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/optimize/nnls creating build/temp.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/optimize/nnls compile options: '-DNPY_NO_DEPRECATED_API=NPY_1_9_API_VERSION -Ibuild/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/optimize/nnls -I/usr/lib64/python2.7/site-packages/numpy/core/include -I/usr/include/python2.7 -c' gcc: build/src.linux-ppc64le-2.7/scipy/optimize/nnls/_nnlsmodule.c build/src.linux-ppc64le-2.7/scipy/optimize/nnls/_nnlsmodule.c:109:12: warning: 'f2py_size' defined but not used [-Wunused-function] static int f2py_size(PyArrayObject* var, ...) ^~~~~~~~~ gcc: build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/optimize/nnls/fortranobject.c compiling Fortran sources Fortran f77 compiler: /usr/bin/gfortran -Wall -g -ffixed-form -fno-second-underscore -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -fPIC -cpp -O3 -funroll-loops Fortran f90 compiler: /usr/bin/gfortran -Wall -g -fno-second-underscore -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -fPIC -cpp -O3 -funroll-loops Fortran fix compiler: /usr/bin/gfortran -Wall -g -ffixed-form -fno-second-underscore -Wall -g -fno-second-underscore -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -fPIC -cpp -O3 -funroll-loops creating build/temp.linux-ppc64le-2.7/scipy/optimize/nnls compile options: '-DNPY_NO_DEPRECATED_API=NPY_1_9_API_VERSION -Ibuild/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/optimize/nnls -I/usr/lib64/python2.7/site-packages/numpy/core/include -I/usr/include/python2.7 -c' gfortran:f77: scipy/optimize/nnls/nnls.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran scipy/optimize/nnls/nnls.f:121:44: CALL H12 (1,NPP1,NPP1+1,M,A(1,J),1,UP,DUMMY,1,1,0) 1 Warning: Rank mismatch in argument 'c' at (1) (rank-1 and scalar) [-Wargument-mismatch] scipy/optimize/nnls/nnls.f:114:0: J=INDEX(IZ) Warning: 'izmax' may be used uninitialized in this function [-Wmaybe-uninitialized] /usr/bin/gfortran -Wall -g -Wl,-z,relro -Wl,-z,now -specs=/usr/lib/rpm/redhat/redhat-hardened-ld -shared build/temp.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/optimize/nnls/_nnlsmodule.o build/temp.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/optimize/nnls/fortranobject.o build/temp.linux-ppc64le-2.7/scipy/optimize/nnls/nnls.o -L/usr/lib/gcc/ppc64le-redhat-linux/8 -L/usr/lib/gcc/ppc64le-redhat-linux/8 -L/usr/lib64 -Lbuild/temp.linux-ppc64le-2.7 -lpython2.7 -lgfortran -o build/lib.linux-ppc64le-2.7/scipy/optimize/_nnls.so building 'scipy.optimize._group_columns' extension compiling C sources C compiler: gcc -pthread -fno-strict-aliasing -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -D_GNU_SOURCE -fPIC -fwrapv -DNDEBUG -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -D_GNU_SOURCE -fPIC -fwrapv -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -fPIC compile options: '-I/usr/lib64/python2.7/site-packages/numpy/core/include -I/usr/include/python2.7 -c' gcc: scipy/optimize/_group_columns.c In file included from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/ndarraytypes.h:1816, from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/ndarrayobject.h:18, from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/arrayobject.h:4, from scipy/optimize/_group_columns.c:435: /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/npy_1_7_deprecated_api.h:15:2: warning: #warning "Using deprecated NumPy API, disable it by " "#defining NPY_NO_DEPRECATED_API NPY_1_7_API_VERSION" [-Wcpp] #warning "Using deprecated NumPy API, disable it by " \ ^~~~~~~ gcc -pthread -shared -Wl,-z,relro -Wl,-z,now -specs=/usr/lib/rpm/redhat/redhat-hardened-ld -Wl,-z,relro -Wl,-z,now -specs=/usr/lib/rpm/redhat/redhat-hardened-ld -shared -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection build/temp.linux-ppc64le-2.7/scipy/optimize/_group_columns.o -L/usr/lib64 -Lbuild/temp.linux-ppc64le-2.7 -lpython2.7 -o build/lib.linux-ppc64le-2.7/scipy/optimize/_group_columns.so building 'scipy.optimize._lsq.givens_elimination' extension compiling C sources C compiler: gcc -pthread -fno-strict-aliasing -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -D_GNU_SOURCE -fPIC -fwrapv -DNDEBUG -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -D_GNU_SOURCE -fPIC -fwrapv -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -fPIC creating build/temp.linux-ppc64le-2.7/scipy/optimize/_lsq compile options: '-I/usr/lib64/python2.7/site-packages/numpy/core/include -I/usr/include/python2.7 -c' gcc: scipy/optimize/_lsq/givens_elimination.c gcc -pthread -shared -Wl,-z,relro -Wl,-z,now -specs=/usr/lib/rpm/redhat/redhat-hardened-ld -Wl,-z,relro -Wl,-z,now -specs=/usr/lib/rpm/redhat/redhat-hardened-ld -shared -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection build/temp.linux-ppc64le-2.7/scipy/optimize/_lsq/givens_elimination.o -L/usr/lib64 -Lbuild/temp.linux-ppc64le-2.7 -lpython2.7 -o build/lib.linux-ppc64le-2.7/scipy/optimize/_lsq/givens_elimination.so building 'scipy.optimize._trlib._trlib' extension compiling C sources C compiler: gcc -pthread -fno-strict-aliasing -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -D_GNU_SOURCE -fPIC -fwrapv -DNDEBUG -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -D_GNU_SOURCE -fPIC -fwrapv -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -fPIC creating build/temp.linux-ppc64le-2.7/scipy/optimize/_trlib compile options: '-DHAVE_CBLAS -I/usr/lib64/python2.7/site-packages/numpy/core/include -Iscipy/optimize/_trlib/trlib -I/usr/lib64/python2.7/site-packages/numpy/core/include -I/usr/include/python2.7 -c' gcc: scipy/optimize/_trlib/trlib_krylov.c scipy/optimize/_trlib/trlib_krylov.c: In function 'trlib_krylov_min': scipy/optimize/_trlib/trlib_krylov.c:725:25: warning: unused variable 'obj' [-Wunused-variable] trlib_flt_t obj = fwork[8]; ^~~ scipy/optimize/_trlib/trlib_krylov.c:734:25: warning: unused variable 'lam' [-Wunused-variable] trlib_flt_t lam = fwork[7]; ^~~ gcc: scipy/optimize/_trlib/trlib_eigen_inverse.c gcc: scipy/optimize/_trlib/trlib_tri_factor.c gcc: scipy/optimize/_trlib/trlib_quadratic_zero.c gcc: scipy/optimize/_trlib/trlib_leftmost.c gcc: scipy/optimize/_trlib/_trlib.c In file included from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/ndarraytypes.h:1816, from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/ndarrayobject.h:18, from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/arrayobject.h:4, from scipy/optimize/_trlib/_trlib.c:436: /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/npy_1_7_deprecated_api.h:15:2: warning: #warning "Using deprecated NumPy API, disable it by " "#defining NPY_NO_DEPRECATED_API NPY_1_7_API_VERSION" [-Wcpp] #warning "Using deprecated NumPy API, disable it by " \ ^~~~~~~ gcc -pthread -shared -Wl,-z,relro -Wl,-z,now -specs=/usr/lib/rpm/redhat/redhat-hardened-ld -Wl,-z,relro -Wl,-z,now -specs=/usr/lib/rpm/redhat/redhat-hardened-ld -shared -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection build/temp.linux-ppc64le-2.7/scipy/optimize/_trlib/_trlib.o build/temp.linux-ppc64le-2.7/scipy/optimize/_trlib/trlib_krylov.o build/temp.linux-ppc64le-2.7/scipy/optimize/_trlib/trlib_eigen_inverse.o build/temp.linux-ppc64le-2.7/scipy/optimize/_trlib/trlib_leftmost.o build/temp.linux-ppc64le-2.7/scipy/optimize/_trlib/trlib_quadratic_zero.o build/temp.linux-ppc64le-2.7/scipy/optimize/_trlib/trlib_tri_factor.o -L/usr/lib64 -L/usr/lib64 -Lbuild/temp.linux-ppc64le-2.7 -lopenblasp -lopenblas -lpython2.7 -o build/lib.linux-ppc64le-2.7/scipy/optimize/_trlib/_trlib.so building 'scipy.signal.sigtools' extension compiling C sources C compiler: gcc -pthread -fno-strict-aliasing -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -D_GNU_SOURCE -fPIC -fwrapv -DNDEBUG -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -D_GNU_SOURCE -fPIC -fwrapv -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -fPIC creating build/temp.linux-ppc64le-2.7/scipy/signal creating build/temp.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/signal compile options: '-DNPY_NO_DEPRECATED_API=NPY_1_9_API_VERSION -Iscipy/signal -I/usr/lib64/python2.7/site-packages/numpy/core/include -I/usr/include/python2.7 -c' gcc: scipy/signal/firfilter.c gcc: scipy/signal/medianfilter.c gcc: build/src.linux-ppc64le-2.7/scipy/signal/correlate_nd.c gcc: scipy/signal/sigtoolsmodule.c gcc: build/src.linux-ppc64le-2.7/scipy/signal/lfilter.c scipy/signal/lfilter.c.src: In function 'scipy_signal_sigtools_linear_filter': scipy/signal/lfilter.c.src:291:50: warning: passing argument 2 of '(int (*)(PyArrayObject *, PyObject *))*(_scipy_signal_ARRAY_API + 2256)' from incompatible pointer type [-Wincompatible-pointer-types] if (PyArray_SetBaseObject(arVi_view, arVi) == -1) { ^~~~ scipy/signal/lfilter.c.src:291:50: note: expected 'PyObject *' {aka 'struct _object *'} but argument is of type 'PyArrayObject *' {aka 'struct tagPyArrayObject *'} gcc -pthread -shared -Wl,-z,relro -Wl,-z,now -specs=/usr/lib/rpm/redhat/redhat-hardened-ld -Wl,-z,relro -Wl,-z,now -specs=/usr/lib/rpm/redhat/redhat-hardened-ld -shared -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection build/temp.linux-ppc64le-2.7/scipy/signal/sigtoolsmodule.o build/temp.linux-ppc64le-2.7/scipy/signal/firfilter.o build/temp.linux-ppc64le-2.7/scipy/signal/medianfilter.o build/temp.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/signal/lfilter.o build/temp.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/signal/correlate_nd.o -L/usr/lib64 -Lbuild/temp.linux-ppc64le-2.7 -lpython2.7 -o build/lib.linux-ppc64le-2.7/scipy/signal/sigtools.so building 'scipy.signal._spectral' extension compiling C sources C compiler: gcc -pthread -fno-strict-aliasing -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -D_GNU_SOURCE -fPIC -fwrapv -DNDEBUG -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -D_GNU_SOURCE -fPIC -fwrapv -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -fPIC compile options: '-I/usr/lib64/python2.7/site-packages/numpy/core/include -I/usr/include/python2.7 -c' gcc: scipy/signal/_spectral.c In file included from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/ndarraytypes.h:1816, from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/ndarrayobject.h:18, from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/arrayobject.h:4, from scipy/signal/_spectral.c:435: /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/npy_1_7_deprecated_api.h:15:2: warning: #warning "Using deprecated NumPy API, disable it by " "#defining NPY_NO_DEPRECATED_API NPY_1_7_API_VERSION" [-Wcpp] #warning "Using deprecated NumPy API, disable it by " \ ^~~~~~~ gcc -pthread -shared -Wl,-z,relro -Wl,-z,now -specs=/usr/lib/rpm/redhat/redhat-hardened-ld -Wl,-z,relro -Wl,-z,now -specs=/usr/lib/rpm/redhat/redhat-hardened-ld -shared -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection build/temp.linux-ppc64le-2.7/scipy/signal/_spectral.o -L/usr/lib64 -Lbuild/temp.linux-ppc64le-2.7 -lpython2.7 -o build/lib.linux-ppc64le-2.7/scipy/signal/_spectral.so building 'scipy.signal._max_len_seq_inner' extension compiling C sources C compiler: gcc -pthread -fno-strict-aliasing -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -D_GNU_SOURCE -fPIC -fwrapv -DNDEBUG -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -D_GNU_SOURCE -fPIC -fwrapv -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -fPIC compile options: '-I/usr/lib64/python2.7/site-packages/numpy/core/include -I/usr/include/python2.7 -c' gcc: scipy/signal/_max_len_seq_inner.c In file included from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/ndarraytypes.h:1816, from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/ndarrayobject.h:18, from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/arrayobject.h:4, from scipy/signal/_max_len_seq_inner.c:435: /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/npy_1_7_deprecated_api.h:15:2: warning: #warning "Using deprecated NumPy API, disable it by " "#defining NPY_NO_DEPRECATED_API NPY_1_7_API_VERSION" [-Wcpp] #warning "Using deprecated NumPy API, disable it by " \ ^~~~~~~ gcc -pthread -shared -Wl,-z,relro -Wl,-z,now -specs=/usr/lib/rpm/redhat/redhat-hardened-ld -Wl,-z,relro -Wl,-z,now -specs=/usr/lib/rpm/redhat/redhat-hardened-ld -shared -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection build/temp.linux-ppc64le-2.7/scipy/signal/_max_len_seq_inner.o -L/usr/lib64 -Lbuild/temp.linux-ppc64le-2.7 -lpython2.7 -o build/lib.linux-ppc64le-2.7/scipy/signal/_max_len_seq_inner.so building 'scipy.signal._upfirdn_apply' extension compiling C sources C compiler: gcc -pthread -fno-strict-aliasing -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -D_GNU_SOURCE -fPIC -fwrapv -DNDEBUG -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -D_GNU_SOURCE -fPIC -fwrapv -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -fPIC compile options: '-I/usr/lib64/python2.7/site-packages/numpy/core/include -I/usr/include/python2.7 -c' gcc: scipy/signal/_upfirdn_apply.c In file included from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/ndarraytypes.h:1816, from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/ndarrayobject.h:18, from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/arrayobject.h:4, from scipy/signal/_upfirdn_apply.c:435: /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/npy_1_7_deprecated_api.h:15:2: warning: #warning "Using deprecated NumPy API, disable it by " "#defining NPY_NO_DEPRECATED_API NPY_1_7_API_VERSION" [-Wcpp] #warning "Using deprecated NumPy API, disable it by " \ ^~~~~~~ gcc -pthread -shared -Wl,-z,relro -Wl,-z,now -specs=/usr/lib/rpm/redhat/redhat-hardened-ld -Wl,-z,relro -Wl,-z,now -specs=/usr/lib/rpm/redhat/redhat-hardened-ld -shared -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection build/temp.linux-ppc64le-2.7/scipy/signal/_upfirdn_apply.o -L/usr/lib64 -Lbuild/temp.linux-ppc64le-2.7 -lpython2.7 -o build/lib.linux-ppc64le-2.7/scipy/signal/_upfirdn_apply.so building 'scipy.signal.spline' extension compiling C sources C compiler: gcc -pthread -fno-strict-aliasing -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -D_GNU_SOURCE -fPIC -fwrapv -DNDEBUG -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -D_GNU_SOURCE -fPIC -fwrapv -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -fPIC compile options: '-DNPY_NO_DEPRECATED_API=NPY_1_9_API_VERSION -I/usr/lib64/python2.7/site-packages/numpy/core/include -I/usr/include/python2.7 -c' gcc: scipy/signal/bspline_util.c gcc: scipy/signal/D_bspline_util.c gcc: scipy/signal/splinemodule.c gcc: scipy/signal/S_bspline_util.c gcc: scipy/signal/Z_bspline_util.c gcc: scipy/signal/C_bspline_util.c gcc -pthread -shared -Wl,-z,relro -Wl,-z,now -specs=/usr/lib/rpm/redhat/redhat-hardened-ld -Wl,-z,relro -Wl,-z,now -specs=/usr/lib/rpm/redhat/redhat-hardened-ld -shared -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection build/temp.linux-ppc64le-2.7/scipy/signal/splinemodule.o build/temp.linux-ppc64le-2.7/scipy/signal/S_bspline_util.o build/temp.linux-ppc64le-2.7/scipy/signal/D_bspline_util.o build/temp.linux-ppc64le-2.7/scipy/signal/C_bspline_util.o build/temp.linux-ppc64le-2.7/scipy/signal/Z_bspline_util.o build/temp.linux-ppc64le-2.7/scipy/signal/bspline_util.o -L/usr/lib64 -Lbuild/temp.linux-ppc64le-2.7 -lpython2.7 -o build/lib.linux-ppc64le-2.7/scipy/signal/spline.so building 'scipy.sparse.linalg.isolve._iterative' extension compiling C sources C compiler: gcc -pthread -fno-strict-aliasing -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -D_GNU_SOURCE -fPIC -fwrapv -DNDEBUG -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -D_GNU_SOURCE -fPIC -fwrapv -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -fPIC creating build/temp.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/sparse creating build/temp.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/sparse/linalg creating build/temp.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/sparse/linalg/isolve creating build/temp.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/sparse/linalg/isolve/iterative creating build/temp.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/sparse creating build/temp.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/sparse/linalg creating build/temp.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/sparse/linalg/isolve creating build/temp.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/sparse/linalg/isolve/iterative compile options: '-DHAVE_CBLAS -Ibuild/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/sparse/linalg/isolve/iterative -I/usr/lib64/python2.7/site-packages/numpy/core/include -I/usr/include/python2.7 -c' gcc: build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/sparse/linalg/isolve/iterative/_iterativemodule.c In file included from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/ndarraytypes.h:1816, from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/ndarrayobject.h:18, from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/arrayobject.h:4, from build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/sparse/linalg/isolve/iterative/fortranobject.h:13, from build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/sparse/linalg/isolve/iterative/_iterativemodule.c:16: /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/npy_1_7_deprecated_api.h:15:2: warning: #warning "Using deprecated NumPy API, disable it by " "#defining NPY_NO_DEPRECATED_API NPY_1_7_API_VERSION" [-Wcpp] #warning "Using deprecated NumPy API, disable it by " \ ^~~~~~~ build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/sparse/linalg/isolve/iterative/_iterativemodule.c:151:12: warning: 'f2py_size' defined but not used [-Wunused-function] static int f2py_size(PyArrayObject* var, ...) ^~~~~~~~~ gcc: build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/sparse/linalg/isolve/iterative/fortranobject.c In file included from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/ndarraytypes.h:1816, from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/ndarrayobject.h:18, from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/arrayobject.h:4, from build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/sparse/linalg/isolve/iterative/fortranobject.h:13, from build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/sparse/linalg/isolve/iterative/fortranobject.c:2: /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/npy_1_7_deprecated_api.h:15:2: warning: #warning "Using deprecated NumPy API, disable it by " "#defining NPY_NO_DEPRECATED_API NPY_1_7_API_VERSION" [-Wcpp] #warning "Using deprecated NumPy API, disable it by " \ ^~~~~~~ compiling Fortran sources Fortran f77 compiler: /usr/bin/gfortran -Wall -g -ffixed-form -fno-second-underscore -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -fPIC -cpp -O3 -funroll-loops Fortran f90 compiler: /usr/bin/gfortran -Wall -g -fno-second-underscore -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -fPIC -cpp -O3 -funroll-loops Fortran fix compiler: /usr/bin/gfortran -Wall -g -ffixed-form -fno-second-underscore -Wall -g -fno-second-underscore -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -fPIC -cpp -O3 -funroll-loops creating build/temp.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/sparse creating build/temp.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/sparse/linalg creating build/temp.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/sparse/linalg/isolve creating build/temp.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/sparse/linalg/isolve/iterative compile options: '-DHAVE_CBLAS -Ibuild/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/sparse/linalg/isolve/iterative -I/usr/lib64/python2.7/site-packages/numpy/core/include -I/usr/include/python2.7 -c' gfortran:f77: build/src.linux-ppc64le-2.7/scipy/sparse/linalg/isolve/iterative/STOPTEST2.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: build/src.linux-ppc64le-2.7/scipy/sparse/linalg/isolve/iterative/getbreak.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: build/src.linux-ppc64le-2.7/scipy/sparse/linalg/isolve/iterative/BiCGREVCOM.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: build/src.linux-ppc64le-2.7/scipy/sparse/linalg/isolve/iterative/BiCGSTABREVCOM.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: build/src.linux-ppc64le-2.7/scipy/sparse/linalg/isolve/iterative/CGREVCOM.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: build/src.linux-ppc64le-2.7/scipy/sparse/linalg/isolve/iterative/CGSREVCOM.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: build/src.linux-ppc64le-2.7/scipy/sparse/linalg/isolve/iterative/GMRESREVCOM.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran build/src.linux-ppc64le-2.7/scipy/sparse/linalg/isolve/iterative/GMRESREVCOM.f:2260:37: $ FUNCTION dzAPPROXRES( I, H, S, GIVENS, LDG ) 1 Warning: Unused dummy argument 'h' at (1) [-Wunused-dummy-argument] build/src.linux-ppc64le-2.7/scipy/sparse/linalg/isolve/iterative/GMRESREVCOM.f:1666:38: $ FUNCTION wscAPPROXRES( I, H, S, GIVENS, LDG ) 1 Warning: Unused dummy argument 'h' at (1) [-Wunused-dummy-argument] build/src.linux-ppc64le-2.7/scipy/sparse/linalg/isolve/iterative/GMRESREVCOM.f:1072:36: $ FUNCTION dAPPROXRES( I, H, S, GIVENS, LDG ) 1 Warning: Unused dummy argument 'h' at (1) [-Wunused-dummy-argument] build/src.linux-ppc64le-2.7/scipy/sparse/linalg/isolve/iterative/GMRESREVCOM.f:478:37: $ FUNCTION wsAPPROXRES( I, H, S, GIVENS, LDG ) 1 Warning: Unused dummy argument 'h' at (1) [-Wunused-dummy-argument] gfortran:f77: build/src.linux-ppc64le-2.7/scipy/sparse/linalg/isolve/iterative/QMRREVCOM.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: /builddir/build/BUILD/scipy-1.0.0/scipy/_build_utils/src/wrap_dummy_g77_abi.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran gfortran:f77: /builddir/build/BUILD/scipy-1.0.0/scipy/_build_utils/src/wrap_dummy_accelerate.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran /usr/bin/gfortran -Wall -g -Wl,-z,relro -Wl,-z,now -specs=/usr/lib/rpm/redhat/redhat-hardened-ld -shared build/temp.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/sparse/linalg/isolve/iterative/_iterativemodule.o build/temp.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/sparse/linalg/isolve/iterative/fortranobject.o build/temp.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/sparse/linalg/isolve/iterative/STOPTEST2.o build/temp.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/sparse/linalg/isolve/iterative/getbreak.o build/temp.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/sparse/linalg/isolve/iterative/BiCGREVCOM.o build/temp.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/sparse/linalg/isolve/iterative/BiCGSTABREVCOM.o build/temp.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/sparse/linalg/isolve/iterative/CGREVCOM.o build/temp.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/sparse/linalg/isolve/iterative/CGSREVCOM.o build/temp.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/sparse/linalg/isolve/iterative/GMRESREVCOM.o build/temp.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/sparse/linalg/isolve/iterative/QMRREVCOM.o build/temp.linux-ppc64le-2.7/builddir/build/BUILD/scipy-1.0.0/scipy/_build_utils/src/wrap_dummy_g77_abi.o build/temp.linux-ppc64le-2.7/builddir/build/BUILD/scipy-1.0.0/scipy/_build_utils/src/wrap_dummy_accelerate.o -L/usr/lib64 -L/usr/lib/gcc/ppc64le-redhat-linux/8 -L/usr/lib/gcc/ppc64le-redhat-linux/8 -L/usr/lib64 -Lbuild/temp.linux-ppc64le-2.7 -Wl,-rpath="/usr/lib64" -lopenblasp -lopenblas -lpython2.7 -lgfortran -o build/lib.linux-ppc64le-2.7/scipy/sparse/linalg/isolve/_iterative.so building 'scipy.sparse.linalg.dsolve._superlu' extension compiling C sources C compiler: gcc -pthread -fno-strict-aliasing -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -D_GNU_SOURCE -fPIC -fwrapv -DNDEBUG -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -D_GNU_SOURCE -fPIC -fwrapv -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -fPIC compile options: '-DNPY_NO_DEPRECATED_API=NPY_1_9_API_VERSION -DHAVE_CBLAS -DUSE_VENDOR_BLAS=1 -I/usr/lib64/python2.7/site-packages/numpy/core/include -I/usr/include/python2.7 -c' gcc: scipy/sparse/linalg/dsolve/_superlu_utils.c In file included from scipy/sparse/linalg/dsolve/_superlu_utils.c:8: scipy/sparse/linalg/dsolve/_superluobject.h:160:19: warning: 'Create_CompCol_Matrix' defined but not used [-Wunused-function] TYPE_GENERIC_FUNC(Create_CompCol_Matrix, void); ^~~~~~~~~~~~~~~~~~~~~ scipy/sparse/linalg/dsolve/_superluobject.h:95:23: note: in definition of macro 'TYPE_GENERIC_FUNC' static returntype name(int type, name##_ARGS) \ ^~~~ scipy/sparse/linalg/dsolve/_superluobject.h:159:19: warning: 'Create_CompRow_Matrix' defined but not used [-Wunused-function] TYPE_GENERIC_FUNC(Create_CompRow_Matrix, void); ^~~~~~~~~~~~~~~~~~~~~ scipy/sparse/linalg/dsolve/_superluobject.h:95:23: note: in definition of macro 'TYPE_GENERIC_FUNC' static returntype name(int type, name##_ARGS) \ ^~~~ scipy/sparse/linalg/dsolve/_superluobject.h:158:19: warning: 'Create_Dense_Matrix' defined but not used [-Wunused-function] TYPE_GENERIC_FUNC(Create_Dense_Matrix, void); ^~~~~~~~~~~~~~~~~~~ scipy/sparse/linalg/dsolve/_superluobject.h:95:23: note: in definition of macro 'TYPE_GENERIC_FUNC' static returntype name(int type, name##_ARGS) \ ^~~~ scipy/sparse/linalg/dsolve/_superluobject.h:157:19: warning: 'gssv' defined but not used [-Wunused-function] TYPE_GENERIC_FUNC(gssv, void); ^~~~ scipy/sparse/linalg/dsolve/_superluobject.h:95:23: note: in definition of macro 'TYPE_GENERIC_FUNC' static returntype name(int type, name##_ARGS) \ ^~~~ scipy/sparse/linalg/dsolve/_superluobject.h:156:19: warning: 'gstrs' defined but not used [-Wunused-function] TYPE_GENERIC_FUNC(gstrs, void); ^~~~~ scipy/sparse/linalg/dsolve/_superluobject.h:95:23: note: in definition of macro 'TYPE_GENERIC_FUNC' static returntype name(int type, name##_ARGS) \ ^~~~ scipy/sparse/linalg/dsolve/_superluobject.h:155:19: warning: 'gsitrf' defined but not used [-Wunused-function] TYPE_GENERIC_FUNC(gsitrf, void); ^~~~~~ scipy/sparse/linalg/dsolve/_superluobject.h:95:23: note: in definition of macro 'TYPE_GENERIC_FUNC' static returntype name(int type, name##_ARGS) \ ^~~~ scipy/sparse/linalg/dsolve/_superluobject.h:154:19: warning: 'gstrf' defined but not used [-Wunused-function] TYPE_GENERIC_FUNC(gstrf, void); ^~~~~ scipy/sparse/linalg/dsolve/_superluobject.h:95:23: note: in definition of macro 'TYPE_GENERIC_FUNC' static returntype name(int type, name##_ARGS) \ ^~~~ gcc: scipy/sparse/linalg/dsolve/_superlumodule.c In file included from scipy/sparse/linalg/dsolve/_superlumodule.c:19: scipy/sparse/linalg/dsolve/_superluobject.h:160:19: warning: 'Create_CompCol_Matrix' defined but not used [-Wunused-function] TYPE_GENERIC_FUNC(Create_CompCol_Matrix, void); ^~~~~~~~~~~~~~~~~~~~~ scipy/sparse/linalg/dsolve/_superluobject.h:95:23: note: in definition of macro 'TYPE_GENERIC_FUNC' static returntype name(int type, name##_ARGS) \ ^~~~ scipy/sparse/linalg/dsolve/_superluobject.h:159:19: warning: 'Create_CompRow_Matrix' defined but not used [-Wunused-function] TYPE_GENERIC_FUNC(Create_CompRow_Matrix, void); ^~~~~~~~~~~~~~~~~~~~~ scipy/sparse/linalg/dsolve/_superluobject.h:95:23: note: in definition of macro 'TYPE_GENERIC_FUNC' static returntype name(int type, name##_ARGS) \ ^~~~ scipy/sparse/linalg/dsolve/_superluobject.h:158:19: warning: 'Create_Dense_Matrix' defined but not used [-Wunused-function] TYPE_GENERIC_FUNC(Create_Dense_Matrix, void); ^~~~~~~~~~~~~~~~~~~ scipy/sparse/linalg/dsolve/_superluobject.h:95:23: note: in definition of macro 'TYPE_GENERIC_FUNC' static returntype name(int type, name##_ARGS) \ ^~~~ scipy/sparse/linalg/dsolve/_superluobject.h:156:19: warning: 'gstrs' defined but not used [-Wunused-function] TYPE_GENERIC_FUNC(gstrs, void); ^~~~~ scipy/sparse/linalg/dsolve/_superluobject.h:95:23: note: in definition of macro 'TYPE_GENERIC_FUNC' static returntype name(int type, name##_ARGS) \ ^~~~ scipy/sparse/linalg/dsolve/_superluobject.h:155:19: warning: 'gsitrf' defined but not used [-Wunused-function] TYPE_GENERIC_FUNC(gsitrf, void); ^~~~~~ scipy/sparse/linalg/dsolve/_superluobject.h:95:23: note: in definition of macro 'TYPE_GENERIC_FUNC' static returntype name(int type, name##_ARGS) \ ^~~~ scipy/sparse/linalg/dsolve/_superluobject.h:154:19: warning: 'gstrf' defined but not used [-Wunused-function] TYPE_GENERIC_FUNC(gstrf, void); ^~~~~ scipy/sparse/linalg/dsolve/_superluobject.h:95:23: note: in definition of macro 'TYPE_GENERIC_FUNC' static returntype name(int type, name##_ARGS) \ ^~~~ gcc: scipy/sparse/linalg/dsolve/_superluobject.c scipy/sparse/linalg/dsolve/_superluobject.c:216:32: warning: missing braces around initializer [-Wmissing-braces] PyGetSetDef SuperLU_getset[] = { ^ scipy/sparse/linalg/dsolve/_superluobject.c: In function 'droprule_one_cvt': scipy/sparse/linalg/dsolve/_superluobject.c:822:10: warning: variable 'i' set but not used [-Wunused-but-set-variable] long i = -1; \ ^ scipy/sparse/linalg/dsolve/_superluobject.c:977:5: note: in expansion of macro 'ENUM_CHECK_INIT' ENUM_CHECK_INIT; ^~~~~~~~~~~~~~~ In file included from scipy/sparse/linalg/dsolve/_superluobject.c:13: At top level: scipy/sparse/linalg/dsolve/_superluobject.h:157:19: warning: 'gssv' defined but not used [-Wunused-function] TYPE_GENERIC_FUNC(gssv, void); ^~~~ scipy/sparse/linalg/dsolve/_superluobject.h:95:23: note: in definition of macro 'TYPE_GENERIC_FUNC' static returntype name(int type, name##_ARGS) \ ^~~~ gcc -pthread -shared -Wl,-z,relro -Wl,-z,now -specs=/usr/lib/rpm/redhat/redhat-hardened-ld -Wl,-z,relro -Wl,-z,now -specs=/usr/lib/rpm/redhat/redhat-hardened-ld -shared -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection build/temp.linux-ppc64le-2.7/scipy/sparse/linalg/dsolve/_superlumodule.o build/temp.linux-ppc64le-2.7/scipy/sparse/linalg/dsolve/_superlu_utils.o build/temp.linux-ppc64le-2.7/scipy/sparse/linalg/dsolve/_superluobject.o -L/usr/lib64 -L/usr/lib64 -Lbuild/temp.linux-ppc64le-2.7 -lsuperlu_src -lopenblasp -lopenblas -lpython2.7 -o build/lib.linux-ppc64le-2.7/scipy/sparse/linalg/dsolve/_superlu.so building 'scipy.sparse.linalg.eigen.arpack._arpack' extension compiling C sources C compiler: gcc -pthread -fno-strict-aliasing -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -D_GNU_SOURCE -fPIC -fwrapv -DNDEBUG -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -D_GNU_SOURCE -fPIC -fwrapv -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -fPIC creating build/temp.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/sparse/linalg/eigen creating build/temp.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/sparse/linalg/eigen/arpack creating build/temp.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/sparse/linalg/eigen creating build/temp.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/sparse/linalg/eigen/arpack compile options: '-DHAVE_CBLAS -Ibuild/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/sparse/linalg/eigen/arpack -I/usr/lib64/python2.7/site-packages/numpy/core/include -I/usr/include/python2.7 -c' gcc: build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/sparse/linalg/eigen/arpack/fortranobject.c In file included from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/ndarraytypes.h:1816, from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/ndarrayobject.h:18, from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/arrayobject.h:4, from build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/sparse/linalg/eigen/arpack/fortranobject.h:13, from build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/sparse/linalg/eigen/arpack/fortranobject.c:2: /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/npy_1_7_deprecated_api.h:15:2: warning: #warning "Using deprecated NumPy API, disable it by " "#defining NPY_NO_DEPRECATED_API NPY_1_7_API_VERSION" [-Wcpp] #warning "Using deprecated NumPy API, disable it by " \ ^~~~~~~ gcc: build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/sparse/linalg/eigen/arpack/_arpackmodule.c In file included from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/ndarraytypes.h:1816, from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/ndarrayobject.h:18, from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/arrayobject.h:4, from build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/sparse/linalg/eigen/arpack/fortranobject.h:13, from build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/sparse/linalg/eigen/arpack/_arpackmodule.c:16: /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/npy_1_7_deprecated_api.h:15:2: warning: #warning "Using deprecated NumPy API, disable it by " "#defining NPY_NO_DEPRECATED_API NPY_1_7_API_VERSION" [-Wcpp] #warning "Using deprecated NumPy API, disable it by " \ ^~~~~~~ build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/sparse/linalg/eigen/arpack/_arpackmodule.c:260:12: warning: 'f2py_size' defined but not used [-Wunused-function] static int f2py_size(PyArrayObject* var, ...) ^~~~~~~~~ compiling Fortran sources Fortran f77 compiler: /usr/bin/gfortran -Wall -g -ffixed-form -fno-second-underscore -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -fPIC -cpp -O3 -funroll-loops Fortran f90 compiler: /usr/bin/gfortran -Wall -g -fno-second-underscore -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -fPIC -cpp -O3 -funroll-loops Fortran fix compiler: /usr/bin/gfortran -Wall -g -ffixed-form -fno-second-underscore -Wall -g -fno-second-underscore -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -fPIC -cpp -O3 -funroll-loops compile options: '-DHAVE_CBLAS -Ibuild/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/sparse/linalg/eigen/arpack -I/usr/lib64/python2.7/site-packages/numpy/core/include -I/usr/include/python2.7 -c' gfortran:f77: build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/sparse/linalg/eigen/arpack/_arpack-f2pywrappers.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran /usr/bin/gfortran -Wall -g -Wl,-z,relro -Wl,-z,now -specs=/usr/lib/rpm/redhat/redhat-hardened-ld -shared build/temp.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/sparse/linalg/eigen/arpack/_arpackmodule.o build/temp.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/sparse/linalg/eigen/arpack/fortranobject.o build/temp.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/sparse/linalg/eigen/arpack/_arpack-f2pywrappers.o -L/usr/lib64 -L/usr/lib/gcc/ppc64le-redhat-linux/8 -L/usr/lib/gcc/ppc64le-redhat-linux/8 -L/usr/lib64 -Lbuild/temp.linux-ppc64le-2.7 -Wl,-rpath="/usr/lib64" -larpack_scipy -lopenblasp -lopenblas -lpython2.7 -lgfortran -o build/lib.linux-ppc64le-2.7/scipy/sparse/linalg/eigen/arpack/_arpack.so building 'scipy.sparse.csgraph._shortest_path' extension compiling C sources C compiler: gcc -pthread -fno-strict-aliasing -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -D_GNU_SOURCE -fPIC -fwrapv -DNDEBUG -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -D_GNU_SOURCE -fPIC -fwrapv -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -fPIC creating build/temp.linux-ppc64le-2.7/scipy/sparse/csgraph compile options: '-I/usr/lib64/python2.7/site-packages/numpy/core/include -I/usr/lib64/python2.7/site-packages/numpy/core/include -I/usr/include/python2.7 -c' gcc: scipy/sparse/csgraph/_shortest_path.c In file included from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/ndarraytypes.h:1816, from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/ndarrayobject.h:18, from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/arrayobject.h:4, from scipy/sparse/csgraph/_shortest_path.c:435: /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/npy_1_7_deprecated_api.h:15:2: warning: #warning "Using deprecated NumPy API, disable it by " "#defining NPY_NO_DEPRECATED_API NPY_1_7_API_VERSION" [-Wcpp] #warning "Using deprecated NumPy API, disable it by " \ ^~~~~~~ gcc -pthread -shared -Wl,-z,relro -Wl,-z,now -specs=/usr/lib/rpm/redhat/redhat-hardened-ld -Wl,-z,relro -Wl,-z,now -specs=/usr/lib/rpm/redhat/redhat-hardened-ld -shared -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection build/temp.linux-ppc64le-2.7/scipy/sparse/csgraph/_shortest_path.o -L/usr/lib64 -Lbuild/temp.linux-ppc64le-2.7 -lpython2.7 -o build/lib.linux-ppc64le-2.7/scipy/sparse/csgraph/_shortest_path.so building 'scipy.sparse.csgraph._traversal' extension compiling C sources C compiler: gcc -pthread -fno-strict-aliasing -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -D_GNU_SOURCE -fPIC -fwrapv -DNDEBUG -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -D_GNU_SOURCE -fPIC -fwrapv -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -fPIC compile options: '-I/usr/lib64/python2.7/site-packages/numpy/core/include -I/usr/lib64/python2.7/site-packages/numpy/core/include -I/usr/include/python2.7 -c' gcc: scipy/sparse/csgraph/_traversal.c In file included from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/ndarraytypes.h:1816, from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/ndarrayobject.h:18, from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/arrayobject.h:4, from scipy/sparse/csgraph/_traversal.c:435: /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/npy_1_7_deprecated_api.h:15:2: warning: #warning "Using deprecated NumPy API, disable it by " "#defining NPY_NO_DEPRECATED_API NPY_1_7_API_VERSION" [-Wcpp] #warning "Using deprecated NumPy API, disable it by " \ ^~~~~~~ gcc -pthread -shared -Wl,-z,relro -Wl,-z,now -specs=/usr/lib/rpm/redhat/redhat-hardened-ld -Wl,-z,relro -Wl,-z,now -specs=/usr/lib/rpm/redhat/redhat-hardened-ld -shared -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection build/temp.linux-ppc64le-2.7/scipy/sparse/csgraph/_traversal.o -L/usr/lib64 -Lbuild/temp.linux-ppc64le-2.7 -lpython2.7 -o build/lib.linux-ppc64le-2.7/scipy/sparse/csgraph/_traversal.so building 'scipy.sparse.csgraph._min_spanning_tree' extension compiling C sources C compiler: gcc -pthread -fno-strict-aliasing -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -D_GNU_SOURCE -fPIC -fwrapv -DNDEBUG -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -D_GNU_SOURCE -fPIC -fwrapv -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -fPIC compile options: '-I/usr/lib64/python2.7/site-packages/numpy/core/include -I/usr/lib64/python2.7/site-packages/numpy/core/include -I/usr/include/python2.7 -c' gcc: scipy/sparse/csgraph/_min_spanning_tree.c In file included from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/ndarraytypes.h:1816, from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/ndarrayobject.h:18, from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/arrayobject.h:4, from scipy/sparse/csgraph/_min_spanning_tree.c:435: /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/npy_1_7_deprecated_api.h:15:2: warning: #warning "Using deprecated NumPy API, disable it by " "#defining NPY_NO_DEPRECATED_API NPY_1_7_API_VERSION" [-Wcpp] #warning "Using deprecated NumPy API, disable it by " \ ^~~~~~~ gcc -pthread -shared -Wl,-z,relro -Wl,-z,now -specs=/usr/lib/rpm/redhat/redhat-hardened-ld -Wl,-z,relro -Wl,-z,now -specs=/usr/lib/rpm/redhat/redhat-hardened-ld -shared -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection build/temp.linux-ppc64le-2.7/scipy/sparse/csgraph/_min_spanning_tree.o -L/usr/lib64 -Lbuild/temp.linux-ppc64le-2.7 -lpython2.7 -o build/lib.linux-ppc64le-2.7/scipy/sparse/csgraph/_min_spanning_tree.so building 'scipy.sparse.csgraph._reordering' extension compiling C sources C compiler: gcc -pthread -fno-strict-aliasing -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -D_GNU_SOURCE -fPIC -fwrapv -DNDEBUG -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -D_GNU_SOURCE -fPIC -fwrapv -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -fPIC compile options: '-I/usr/lib64/python2.7/site-packages/numpy/core/include -I/usr/lib64/python2.7/site-packages/numpy/core/include -I/usr/include/python2.7 -c' gcc: scipy/sparse/csgraph/_reordering.c In file included from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/ndarraytypes.h:1816, from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/ndarrayobject.h:18, from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/arrayobject.h:4, from scipy/sparse/csgraph/_reordering.c:435: /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/npy_1_7_deprecated_api.h:15:2: warning: #warning "Using deprecated NumPy API, disable it by " "#defining NPY_NO_DEPRECATED_API NPY_1_7_API_VERSION" [-Wcpp] #warning "Using deprecated NumPy API, disable it by " \ ^~~~~~~ gcc -pthread -shared -Wl,-z,relro -Wl,-z,now -specs=/usr/lib/rpm/redhat/redhat-hardened-ld -Wl,-z,relro -Wl,-z,now -specs=/usr/lib/rpm/redhat/redhat-hardened-ld -shared -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection build/temp.linux-ppc64le-2.7/scipy/sparse/csgraph/_reordering.o -L/usr/lib64 -Lbuild/temp.linux-ppc64le-2.7 -lpython2.7 -o build/lib.linux-ppc64le-2.7/scipy/sparse/csgraph/_reordering.so building 'scipy.sparse.csgraph._tools' extension compiling C sources C compiler: gcc -pthread -fno-strict-aliasing -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -D_GNU_SOURCE -fPIC -fwrapv -DNDEBUG -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -D_GNU_SOURCE -fPIC -fwrapv -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -fPIC compile options: '-I/usr/lib64/python2.7/site-packages/numpy/core/include -I/usr/lib64/python2.7/site-packages/numpy/core/include -I/usr/include/python2.7 -c' gcc: scipy/sparse/csgraph/_tools.c In file included from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/ndarraytypes.h:1816, from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/ndarrayobject.h:18, from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/arrayobject.h:4, from scipy/sparse/csgraph/_tools.c:435: /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/npy_1_7_deprecated_api.h:15:2: warning: #warning "Using deprecated NumPy API, disable it by " "#defining NPY_NO_DEPRECATED_API NPY_1_7_API_VERSION" [-Wcpp] #warning "Using deprecated NumPy API, disable it by " \ ^~~~~~~ gcc -pthread -shared -Wl,-z,relro -Wl,-z,now -specs=/usr/lib/rpm/redhat/redhat-hardened-ld -Wl,-z,relro -Wl,-z,now -specs=/usr/lib/rpm/redhat/redhat-hardened-ld -shared -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection build/temp.linux-ppc64le-2.7/scipy/sparse/csgraph/_tools.o -L/usr/lib64 -Lbuild/temp.linux-ppc64le-2.7 -lpython2.7 -o build/lib.linux-ppc64le-2.7/scipy/sparse/csgraph/_tools.so building 'scipy.sparse._csparsetools' extension compiling C sources C compiler: gcc -pthread -fno-strict-aliasing -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -D_GNU_SOURCE -fPIC -fwrapv -DNDEBUG -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -D_GNU_SOURCE -fPIC -fwrapv -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -fPIC compile options: '-I/usr/lib64/python2.7/site-packages/numpy/core/include -I/usr/include/python2.7 -c' gcc: scipy/sparse/_csparsetools.c In file included from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/ndarraytypes.h:1816, from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/ndarrayobject.h:18, from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/arrayobject.h:4, from scipy/sparse/_csparsetools.c:435: /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/npy_1_7_deprecated_api.h:15:2: warning: #warning "Using deprecated NumPy API, disable it by " "#defining NPY_NO_DEPRECATED_API NPY_1_7_API_VERSION" [-Wcpp] #warning "Using deprecated NumPy API, disable it by " \ ^~~~~~~ gcc -pthread -shared -Wl,-z,relro -Wl,-z,now -specs=/usr/lib/rpm/redhat/redhat-hardened-ld -Wl,-z,relro -Wl,-z,now -specs=/usr/lib/rpm/redhat/redhat-hardened-ld -shared -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection build/temp.linux-ppc64le-2.7/scipy/sparse/_csparsetools.o -L/usr/lib64 -Lbuild/temp.linux-ppc64le-2.7 -lpython2.7 -o build/lib.linux-ppc64le-2.7/scipy/sparse/_csparsetools.so building 'scipy.sparse._sparsetools' extension compiling C++ sources C compiler: g++ -pthread -fno-strict-aliasing -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -D_GNU_SOURCE -fPIC -fwrapv -DNDEBUG -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -D_GNU_SOURCE -fPIC -fwrapv -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -fPIC creating build/temp.linux-ppc64le-2.7/scipy/sparse/sparsetools compile options: '-D__STDC_FORMAT_MACROS=1 -Iscipy/sparse/sparsetools -I/usr/lib64/python2.7/site-packages/numpy/core/include -I/usr/include/python2.7 -c' g++: scipy/sparse/sparsetools/sparsetools.cxx In file included from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/ndarraytypes.h:1816, from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/ndarrayobject.h:18, from scipy/sparse/sparsetools/sparsetools.cxx:34: /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/npy_1_7_deprecated_api.h:15:2: warning: #warning "Using deprecated NumPy API, disable it by " "#defining NPY_NO_DEPRECATED_API NPY_1_7_API_VERSION" [-Wcpp] #warning "Using deprecated NumPy API, disable it by " \ ^~~~~~~ g++: scipy/sparse/sparsetools/csr.cxx In file included from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/ndarraytypes.h:1816, from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/ndarrayobject.h:18, from scipy/sparse/sparsetools/sparsetools.h:5, from scipy/sparse/sparsetools/csr.cxx:4: /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/npy_1_7_deprecated_api.h:15:2: warning: #warning "Using deprecated NumPy API, disable it by " "#defining NPY_NO_DEPRECATED_API NPY_1_7_API_VERSION" [-Wcpp] #warning "Using deprecated NumPy API, disable it by " \ ^~~~~~~ In file included from scipy/sparse/sparsetools/csr.h:10, from scipy/sparse/sparsetools/csr.cxx:5: scipy/sparse/sparsetools/dense.h: In function 'void axpy(I, T, const T*, T*) [with I = int; T = complex_wrapper]': scipy/sparse/sparsetools/dense.h:12:6: note: the ABI of passing aggregates with 16-byte alignment has changed in GCC 5 void axpy(const I n, const T a, const T * x, T * y){ ^~~~ g++: scipy/sparse/sparsetools/bsr.cxx In file included from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/ndarraytypes.h:1816, from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/ndarrayobject.h:18, from scipy/sparse/sparsetools/sparsetools.h:5, from scipy/sparse/sparsetools/bsr.cxx:4: /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/npy_1_7_deprecated_api.h:15:2: warning: #warning "Using deprecated NumPy API, disable it by " "#defining NPY_NO_DEPRECATED_API NPY_1_7_API_VERSION" [-Wcpp] #warning "Using deprecated NumPy API, disable it by " \ ^~~~~~~ In file included from scipy/sparse/sparsetools/csr.h:10, from scipy/sparse/sparsetools/bsr.h:8, from scipy/sparse/sparsetools/bsr.cxx:5: scipy/sparse/sparsetools/dense.h: In function 'void scal(I, T, T*) [with I = int; T = complex_wrapper]': scipy/sparse/sparsetools/dense.h:20:6: note: the ABI of passing aggregates with 16-byte alignment has changed in GCC 5 void scal(const I n, const T a, T * x){ ^~~~ g++: scipy/sparse/sparsetools/csc.cxx In file included from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/ndarraytypes.h:1816, from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/ndarrayobject.h:18, from scipy/sparse/sparsetools/sparsetools.h:5, from scipy/sparse/sparsetools/csc.cxx:4: /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/npy_1_7_deprecated_api.h:15:2: warning: #warning "Using deprecated NumPy API, disable it by " "#defining NPY_NO_DEPRECATED_API NPY_1_7_API_VERSION" [-Wcpp] #warning "Using deprecated NumPy API, disable it by " \ ^~~~~~~ In file included from scipy/sparse/sparsetools/csr.h:10, from scipy/sparse/sparsetools/csc.h:4, from scipy/sparse/sparsetools/csc.cxx:5: scipy/sparse/sparsetools/dense.h: In function 'void axpy(I, T, const T*, T*) [with I = int; T = complex_wrapper]': scipy/sparse/sparsetools/dense.h:12:6: note: the ABI of passing aggregates with 16-byte alignment has changed in GCC 5 void axpy(const I n, const T a, const T * x, T * y){ ^~~~ g++: scipy/sparse/sparsetools/other.cxx In file included from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/ndarraytypes.h:1816, from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/ndarrayobject.h:18, from scipy/sparse/sparsetools/sparsetools.h:5, from scipy/sparse/sparsetools/other.cxx:4: /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/npy_1_7_deprecated_api.h:15:2: warning: #warning "Using deprecated NumPy API, disable it by " "#defining NPY_NO_DEPRECATED_API NPY_1_7_API_VERSION" [-Wcpp] #warning "Using deprecated NumPy API, disable it by " \ ^~~~~~~ g++ -pthread -shared -Wl,-z,relro -Wl,-z,now -specs=/usr/lib/rpm/redhat/redhat-hardened-ld -Wl,-z,relro -Wl,-z,now -specs=/usr/lib/rpm/redhat/redhat-hardened-ld -shared -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection build/temp.linux-ppc64le-2.7/scipy/sparse/sparsetools/sparsetools.o build/temp.linux-ppc64le-2.7/scipy/sparse/sparsetools/csr.o build/temp.linux-ppc64le-2.7/scipy/sparse/sparsetools/csc.o build/temp.linux-ppc64le-2.7/scipy/sparse/sparsetools/bsr.o build/temp.linux-ppc64le-2.7/scipy/sparse/sparsetools/other.o -L/usr/lib64 -Lbuild/temp.linux-ppc64le-2.7 -lpython2.7 -o build/lib.linux-ppc64le-2.7/scipy/sparse/_sparsetools.so building 'scipy.spatial.qhull' extension compiling C sources C compiler: gcc -pthread -fno-strict-aliasing -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -D_GNU_SOURCE -fPIC -fwrapv -DNDEBUG -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -D_GNU_SOURCE -fPIC -fwrapv -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -fPIC creating build/temp.linux-ppc64le-2.7/scipy/spatial creating build/temp.linux-ppc64le-2.7/scipy/spatial/qhull creating build/temp.linux-ppc64le-2.7/scipy/spatial/qhull/src compile options: '-DHAVE_CBLAS -I/usr/include/python2.7 -I/usr/lib64/python2.7/site-packages/numpy/core/include -I/usr/lib64/python2.7/site-packages/numpy/core/include -I/usr/include/python2.7 -c' gcc: scipy/spatial/qhull/src/io_r.c In file included from scipy/spatial/qhull/src/libqhull_r.h:32, from scipy/spatial/qhull/src/qhull_ra.h:28, from scipy/spatial/qhull/src/io_r.c:21: scipy/spatial/qhull/src/io_r.c: In function 'qh_printfacetridges': scipy/spatial/qhull/src/qset_r.h:143:38: warning: this 'for' clause does not guard... [-Wmisleading-indentation] if (((variable= NULL), set)) for (\ ^~~ scipy/spatial/qhull/src/libqhull_r.h:926:34: note: in expansion of macro 'FOREACHsetelement_' #define FOREACHridge_(ridges) FOREACHsetelement_(ridgeT, ridges, ridge) ^~~~~~~~~~~~~~~~~~ scipy/spatial/qhull/src/io_r.c:2622:7: note: in expansion of macro 'FOREACHridge_' FOREACHridge_(facet->ridges) ^~~~~~~~~~~~~ scipy/spatial/qhull/src/io_r.c:2624:9: note: ...this statement, but the latter is misleadingly indented as if it were guarded by the 'for' qh_fprintf(qh, fp, 9185, "\n"); ^~~~~~~~~~ gcc: scipy/spatial/qhull/src/poly_r.c scipy/spatial/qhull/src/poly_r.c: In function 'qh_delfacet': scipy/spatial/qhull/src/poly_r.c:248:10: warning: variable 'freelistp' set but not used [-Wunused-but-set-variable] void **freelistp; /* used if !qh_NOmem by qh_memfree_() */ ^~~~~~~~~ scipy/spatial/qhull/src/poly_r.c: In function 'qh_makenew_nonsimplicial': scipy/spatial/qhull/src/poly_r.c:564:10: warning: variable 'freelistp' set but not used [-Wunused-but-set-variable] void **freelistp; /* used if !qh_NOmem by qh_memfree_() */ ^~~~~~~~~ scipy/spatial/qhull/src/poly_r.c: In function 'qh_newfacet': scipy/spatial/qhull/src/poly_r.c:987:10: warning: variable 'freelistp' set but not used [-Wunused-but-set-variable] void **freelistp; /* used if !qh_NOmem by qh_memalloc_() */ ^~~~~~~~~ scipy/spatial/qhull/src/poly_r.c: In function 'qh_newridge': scipy/spatial/qhull/src/poly_r.c:1020:10: warning: variable 'freelistp' set but not used [-Wunused-but-set-variable] void **freelistp; /* used if !qh_NOmem by qh_memalloc_() */ ^~~~~~~~~ gcc: scipy/spatial/qhull/src/user_r.c gcc: scipy/spatial/qhull/src/libqhull_r.c gcc: scipy/spatial/qhull/src/geom_r.c scipy/spatial/qhull/src/geom_r.c: In function 'qh_projectpoint': scipy/spatial/qhull/src/geom_r.c:897:10: warning: variable 'freelistp' set but not used [-Wunused-but-set-variable] void **freelistp; /* used if !qh_NOmem by qh_memalloc_() */ ^~~~~~~~~ scipy/spatial/qhull/src/geom_r.c: In function 'qh_setfacetplane': scipy/spatial/qhull/src/geom_r.c:935:10: warning: variable 'freelistp' set but not used [-Wunused-but-set-variable] void **freelistp; /* used if !qh_NOmem by qh_memalloc_() */ ^~~~~~~~~ gcc: scipy/spatial/qhull/src/global_r.c gcc: scipy/spatial/qhull/src/userprintf_r.c gcc: scipy/spatial/qhull/src/mem_r.c gcc: scipy/spatial/qhull/src/usermem_r.c gcc: scipy/spatial/qhull/src/poly2_r.c scipy/spatial/qhull/src/poly2_r.c: In function 'qh_delridge': scipy/spatial/qhull/src/poly2_r.c:1127:10: warning: variable 'freelistp' set but not used [-Wunused-but-set-variable] void **freelistp; /* used if !qh_NOmem by qh_memfree_() */ ^~~~~~~~~ gcc: scipy/spatial/qhull/src/userprintf_rbox_r.c gcc: scipy/spatial/qhull/src/stat_r.c gcc: scipy/spatial/qhull/src/merge_r.c scipy/spatial/qhull/src/merge_r.c: In function 'qh_all_merges': scipy/spatial/qhull/src/merge_r.c:219:10: warning: variable 'freelistp' set but not used [-Wunused-but-set-variable] void **freelistp; /* used if !qh_NOmem by qh_memfree_() */ ^~~~~~~~~ scipy/spatial/qhull/src/merge_r.c: In function 'qh_appendmergeset': scipy/spatial/qhull/src/merge_r.c:322:10: warning: variable 'freelistp' set but not used [-Wunused-but-set-variable] void **freelistp; /* used if !qh_NOmem by qh_memalloc_() */ ^~~~~~~~~ scipy/spatial/qhull/src/merge_r.c: In function 'qh_mergecycle_ridges': scipy/spatial/qhull/src/merge_r.c:2090:10: warning: variable 'freelistp' set but not used [-Wunused-but-set-variable] void **freelistp; /* used if !qh_NOmem by qh_memfree_() */ ^~~~~~~~~ gcc: scipy/spatial/qhull/src/qset_r.c scipy/spatial/qhull/src/qset_r.c: In function 'qh_setfree': scipy/spatial/qhull/src/qset_r.c:718:10: warning: variable 'freelistp' set but not used [-Wunused-but-set-variable] void **freelistp; /* used if !qh_NOmem by qh_memfree_() */ ^~~~~~~~~ scipy/spatial/qhull/src/qset_r.c: In function 'qh_setnew': scipy/spatial/qhull/src/qset_r.c:928:10: warning: variable 'freelistp' set but not used [-Wunused-but-set-variable] void **freelistp; /* used if !qh_NOmem by qh_memalloc_() */ ^~~~~~~~~ gcc: scipy/spatial/qhull.c In file included from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/ndarraytypes.h:1816, from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/ndarrayobject.h:18, from scipy/spatial/qhull.c:432: /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/npy_1_7_deprecated_api.h:15:2: warning: #warning "Using deprecated NumPy API, disable it by " "#defining NPY_NO_DEPRECATED_API NPY_1_7_API_VERSION" [-Wcpp] #warning "Using deprecated NumPy API, disable it by " \ ^~~~~~~ scipy/spatial/qhull.c: In function '__pyx_pf_5scipy_7spatial_5qhull_6_Qhull_24get_voronoi_diagram': scipy/spatial/qhull.c:9733:66: warning: passing argument 3 of 'qh_eachvoronoi_all' from incompatible pointer type [-Wincompatible-pointer-types] qh_eachvoronoi_all(__pyx_v_self->_qh, ((void *)__pyx_v_self), (&__pyx_f_5scipy_7spatial_5qhull__visit_voronoi), (__pyx_v_self->_qh[0]).UPPERdelaunay, qh_RIDGEall, 1); ~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ In file included from scipy/spatial/qhull.c:445: scipy/spatial/qhull/src/io_r.h:94:60: note: expected 'printvridgeT' {aka 'void (*)(struct qhT *, struct _IO_FILE *, struct vertexT *, struct vertexT *, struct setT *, unsigned int)'} but argument is of type 'void (*)(qhT *, void *, vertexT *, vertexT *, setT *, unsigned int)' {aka 'void (*)(struct qhT *, void *, struct vertexT *, struct vertexT *, struct setT *, unsigned int)'} int qh_eachvoronoi_all(qhT *qh, FILE *fp, printvridgeT printvridge, boolT isUpper, qh_RIDGE innerouter, boolT inorder); ~~~~~~~~~~~~~^~~~~~~~~~~ In file included from scipy/spatial/qhull.c:449: scipy/spatial/qhull.c: In function '__pyx_pf_5scipy_7spatial_5qhull__get_barycentric_transforms': scipy/spatial/qhull_misc.h:19:26: warning: implicit declaration of function 'dgetrf_'; did you mean 'getid_'? [-Wimplicit-function-declaration] #define qh_dgetrf F_FUNC(dgetrf,DGETRF) ^~~~~~ scipy/spatial/qhull_misc.h:15:21: note: in definition of macro 'F_FUNC' #define F_FUNC(f,F) f##_ ^ scipy/spatial/qhull.c:12968:11: note: in expansion of macro 'qh_dgetrf' qh_dgetrf((&__pyx_v_n), (&__pyx_v_n), ((double *)__pyx_v_T->data), (&__pyx_v_lda), __pyx_v_ipiv, (&__pyx_v_info)); ^~~~~~~~~ scipy/spatial/qhull_misc.h:20:26: warning: implicit declaration of function 'dgecon_'; did you mean 'daemon'? [-Wimplicit-function-declaration] #define qh_dgecon F_FUNC(dgecon,DGECON) ^~~~~~ scipy/spatial/qhull_misc.h:15:21: note: in definition of macro 'F_FUNC' #define F_FUNC(f,F) f##_ ^ scipy/spatial/qhull.c:12987:13: note: in expansion of macro 'qh_dgecon' qh_dgecon(((char *)"1"), (&__pyx_v_n), ((double *)__pyx_v_T->data), (&__pyx_v_lda), (&__pyx_v_anorm), (&__pyx_v_rcond), __pyx_v_work, __pyx_v_iwork, (&__pyx_v_info)); ^~~~~~~~~ scipy/spatial/qhull_misc.h:21:26: warning: implicit declaration of function 'dgetrs_'; did you mean 'fgetws'? [-Wimplicit-function-declaration] #define qh_dgetrs F_FUNC(dgetrs,DGETRS) ^~~~~~ scipy/spatial/qhull_misc.h:15:21: note: in definition of macro 'F_FUNC' #define F_FUNC(f,F) f##_ ^ scipy/spatial/qhull.c:13043:13: note: in expansion of macro 'qh_dgetrs' qh_dgetrs(((char *)"N"), (&__pyx_v_n), (&__pyx_v_nrhs), ((double *)__pyx_v_T->data), (&__pyx_v_lda), __pyx_v_ipiv, (((double *)__pyx_v_Tinvs->data) + ((__pyx_v_ndim * (__pyx_v_ndim + 1)) * __pyx_v_isimplex)), (&__pyx_v_ldb), (&__pyx_v_info)); ^~~~~~~~~ gcc: scipy/spatial/qhull/src/random_r.c scipy/spatial/qhull/src/random_r.c: In function 'qh_argv_to_command': scipy/spatial/qhull/src/random_r.c:84:6: warning: this 'else' clause does not guard... [-Wmisleading-indentation] }else ^~~~ scipy/spatial/qhull/src/random_r.c:86:7: note: ...this statement, but the latter is misleadingly indented as if it were guarded by the 'else' strcat(command, s); ^~~~~~ gcc: scipy/spatial/qhull/src/rboxlib_r.c gcc: scipy/spatial/qhull/src/geom2_r.c gcc -pthread -shared -Wl,-z,relro -Wl,-z,now -specs=/usr/lib/rpm/redhat/redhat-hardened-ld -Wl,-z,relro -Wl,-z,now -specs=/usr/lib/rpm/redhat/redhat-hardened-ld -shared -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection build/temp.linux-ppc64le-2.7/scipy/spatial/qhull.o build/temp.linux-ppc64le-2.7/scipy/spatial/qhull/src/usermem_r.o build/temp.linux-ppc64le-2.7/scipy/spatial/qhull/src/libqhull_r.o build/temp.linux-ppc64le-2.7/scipy/spatial/qhull/src/userprintf_r.o build/temp.linux-ppc64le-2.7/scipy/spatial/qhull/src/qset_r.o build/temp.linux-ppc64le-2.7/scipy/spatial/qhull/src/io_r.o build/temp.linux-ppc64le-2.7/scipy/spatial/qhull/src/rboxlib_r.o build/temp.linux-ppc64le-2.7/scipy/spatial/qhull/src/stat_r.o build/temp.linux-ppc64le-2.7/scipy/spatial/qhull/src/geom2_r.o build/temp.linux-ppc64le-2.7/scipy/spatial/qhull/src/user_r.o build/temp.linux-ppc64le-2.7/scipy/spatial/qhull/src/poly_r.o build/temp.linux-ppc64le-2.7/scipy/spatial/qhull/src/geom_r.o build/temp.linux-ppc64le-2.7/scipy/spatial/qhull/src/mem_r.o build/temp.linux-ppc64le-2.7/scipy/spatial/qhull/src/global_r.o build/temp.linux-ppc64le-2.7/scipy/spatial/qhull/src/random_r.o build/temp.linux-ppc64le-2.7/scipy/spatial/qhull/src/merge_r.o build/temp.linux-ppc64le-2.7/scipy/spatial/qhull/src/userprintf_rbox_r.o build/temp.linux-ppc64le-2.7/scipy/spatial/qhull/src/poly2_r.o -L/usr/lib64 -L/usr/lib64 -Lbuild/temp.linux-ppc64le-2.7 -lopenblasp -lopenblas -lpython2.7 -o build/lib.linux-ppc64le-2.7/scipy/spatial/qhull.so building 'scipy.spatial.ckdtree' extension compiling C++ sources C compiler: g++ -pthread -fno-strict-aliasing -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -D_GNU_SOURCE -fPIC -fwrapv -DNDEBUG -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -D_GNU_SOURCE -fPIC -fwrapv -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -fPIC creating build/temp.linux-ppc64le-2.7/scipy/spatial/ckdtree creating build/temp.linux-ppc64le-2.7/scipy/spatial/ckdtree/src compile options: '-I/usr/include/python2.7 -I/usr/lib64/python2.7/site-packages/numpy/core/include -Iscipy/spatial/ckdtree/src -I/usr/lib64/python2.7/site-packages/numpy/core/include -I/usr/include/python2.7 -c' g++: scipy/spatial/ckdtree/src/cpp_exc.cxx In file included from /usr/include/python2.7/pyconfig.h:6, from /usr/include/python2.7/Python.h:8, from scipy/spatial/ckdtree/src/cpp_exc.cxx:12: /usr/include/python2.7/pyconfig-64.h:1232: warning: "_POSIX_C_SOURCE" redefined #define _POSIX_C_SOURCE 200112L In file included from /usr/include/c++/8/ppc64le-redhat-linux/bits/os_defines.h:39, from /usr/include/c++/8/ppc64le-redhat-linux/bits/c++config.h:508, from /usr/include/c++/8/new:39, from scipy/spatial/ckdtree/src/cpp_exc.cxx:7: /usr/include/features.h:265: note: this is the location of the previous definition # define _POSIX_C_SOURCE 200809L In file included from /usr/include/python2.7/pyconfig.h:6, from /usr/include/python2.7/Python.h:8, from scipy/spatial/ckdtree/src/cpp_exc.cxx:12: /usr/include/python2.7/pyconfig-64.h:1254: warning: "_XOPEN_SOURCE" redefined #define _XOPEN_SOURCE 600 In file included from /usr/include/c++/8/ppc64le-redhat-linux/bits/os_defines.h:39, from /usr/include/c++/8/ppc64le-redhat-linux/bits/c++config.h:508, from /usr/include/c++/8/new:39, from scipy/spatial/ckdtree/src/cpp_exc.cxx:7: /usr/include/features.h:202: note: this is the location of the previous definition # define _XOPEN_SOURCE 700 g++: scipy/spatial/ckdtree/src/build.cxx In file included from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/ndarraytypes.h:1816, from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/ndarrayobject.h:18, from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/arrayobject.h:4, from scipy/spatial/ckdtree/src/build.cxx:2: /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/npy_1_7_deprecated_api.h:15:2: warning: #warning "Using deprecated NumPy API, disable it by " "#defining NPY_NO_DEPRECATED_API NPY_1_7_API_VERSION" [-Wcpp] #warning "Using deprecated NumPy API, disable it by " \ ^~~~~~~ In file included from scipy/spatial/ckdtree/src/build.cxx:21: scipy/spatial/ckdtree/src/cpp_utils.h:91:1: warning: 'PyObject* unpickle_tree_buffer(std::vector*, PyObject*)' defined but not used [-Wunused-function] unpickle_tree_buffer(std::vector *buf, PyObject *src) ^~~~~~~~~~~~~~~~~~~~ scipy/spatial/ckdtree/src/cpp_utils.h:82:1: warning: 'PyObject* pickle_tree_buffer(std::vector*)' defined but not used [-Wunused-function] pickle_tree_buffer(std::vector *buf) ^~~~~~~~~~~~~~~~~~ In file included from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/ndarrayobject.h:27, from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/arrayobject.h:4, from scipy/spatial/ckdtree/src/build.cxx:2: /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/__multiarray_api.h:1463:1: warning: 'int _import_array()' defined but not used [-Wunused-function] _import_array(void) ^~~~~~~~~~~~~ g++: scipy/spatial/ckdtree/src/query_pairs.cxx In file included from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/ndarraytypes.h:1816, from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/ndarrayobject.h:18, from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/arrayobject.h:4, from scipy/spatial/ckdtree/src/query_pairs.cxx:2: /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/npy_1_7_deprecated_api.h:15:2: warning: #warning "Using deprecated NumPy API, disable it by " "#defining NPY_NO_DEPRECATED_API NPY_1_7_API_VERSION" [-Wcpp] #warning "Using deprecated NumPy API, disable it by " \ ^~~~~~~ In file included from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/ndarrayobject.h:27, from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/arrayobject.h:4, from scipy/spatial/ckdtree/src/query_pairs.cxx:2: /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/__multiarray_api.h:1463:1: warning: 'int _import_array()' defined but not used [-Wunused-function] _import_array(void) ^~~~~~~~~~~~~ g++: scipy/spatial/ckdtree/src/query_ball_point.cxx In file included from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/ndarraytypes.h:1816, from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/ndarrayobject.h:18, from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/arrayobject.h:4, from scipy/spatial/ckdtree/src/query_ball_point.cxx:2: /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/npy_1_7_deprecated_api.h:15:2: warning: #warning "Using deprecated NumPy API, disable it by " "#defining NPY_NO_DEPRECATED_API NPY_1_7_API_VERSION" [-Wcpp] #warning "Using deprecated NumPy API, disable it by " \ ^~~~~~~ In file included from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/ndarrayobject.h:27, from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/arrayobject.h:4, from scipy/spatial/ckdtree/src/query_ball_point.cxx:2: /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/__multiarray_api.h:1463:1: warning: 'int _import_array()' defined but not used [-Wunused-function] _import_array(void) ^~~~~~~~~~~~~ g++: scipy/spatial/ckdtree/src/query.cxx In file included from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/ndarraytypes.h:1816, from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/ndarrayobject.h:18, from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/arrayobject.h:4, from scipy/spatial/ckdtree/src/query.cxx:9: /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/npy_1_7_deprecated_api.h:15:2: warning: #warning "Using deprecated NumPy API, disable it by " "#defining NPY_NO_DEPRECATED_API NPY_1_7_API_VERSION" [-Wcpp] #warning "Using deprecated NumPy API, disable it by " \ ^~~~~~~ In file included from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/ndarrayobject.h:27, from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/arrayobject.h:4, from scipy/spatial/ckdtree/src/query.cxx:9: /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/__multiarray_api.h:1463:1: warning: 'int _import_array()' defined but not used [-Wunused-function] _import_array(void) ^~~~~~~~~~~~~ g++: scipy/spatial/ckdtree/src/count_neighbors.cxx In file included from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/ndarraytypes.h:1816, from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/ndarrayobject.h:18, from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/arrayobject.h:4, from scipy/spatial/ckdtree/src/count_neighbors.cxx:2: /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/npy_1_7_deprecated_api.h:15:2: warning: #warning "Using deprecated NumPy API, disable it by " "#defining NPY_NO_DEPRECATED_API NPY_1_7_API_VERSION" [-Wcpp] #warning "Using deprecated NumPy API, disable it by " \ ^~~~~~~ In file included from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/ndarrayobject.h:27, from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/arrayobject.h:4, from scipy/spatial/ckdtree/src/count_neighbors.cxx:2: /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/__multiarray_api.h:1463:1: warning: 'int _import_array()' defined but not used [-Wunused-function] _import_array(void) ^~~~~~~~~~~~~ g++: scipy/spatial/ckdtree/src/sparse_distances.cxx In file included from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/ndarraytypes.h:1816, from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/ndarrayobject.h:18, from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/arrayobject.h:4, from scipy/spatial/ckdtree/src/sparse_distances.cxx:3: /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/npy_1_7_deprecated_api.h:15:2: warning: #warning "Using deprecated NumPy API, disable it by " "#defining NPY_NO_DEPRECATED_API NPY_1_7_API_VERSION" [-Wcpp] #warning "Using deprecated NumPy API, disable it by " \ ^~~~~~~ In file included from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/ndarrayobject.h:27, from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/arrayobject.h:4, from scipy/spatial/ckdtree/src/sparse_distances.cxx:3: /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/__multiarray_api.h:1463:1: warning: 'int _import_array()' defined but not used [-Wunused-function] _import_array(void) ^~~~~~~~~~~~~ g++: scipy/spatial/ckdtree/src/globals.cxx g++: scipy/spatial/ckdtree.cxx In file included from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/ndarraytypes.h:1816, from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/ndarrayobject.h:18, from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/arrayobject.h:4, from scipy/spatial/ckdtree.cxx:449: /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/npy_1_7_deprecated_api.h:15:2: warning: #warning "Using deprecated NumPy API, disable it by " "#defining NPY_NO_DEPRECATED_API NPY_1_7_API_VERSION" [-Wcpp] #warning "Using deprecated NumPy API, disable it by " \ ^~~~~~~ g++: scipy/spatial/ckdtree/src/query_ball_tree.cxx In file included from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/ndarraytypes.h:1816, from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/ndarrayobject.h:18, from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/arrayobject.h:4, from scipy/spatial/ckdtree/src/query_ball_tree.cxx:2: /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/npy_1_7_deprecated_api.h:15:2: warning: #warning "Using deprecated NumPy API, disable it by " "#defining NPY_NO_DEPRECATED_API NPY_1_7_API_VERSION" [-Wcpp] #warning "Using deprecated NumPy API, disable it by " \ ^~~~~~~ In file included from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/ndarrayobject.h:27, from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/arrayobject.h:4, from scipy/spatial/ckdtree/src/query_ball_tree.cxx:2: /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/__multiarray_api.h:1463:1: warning: 'int _import_array()' defined but not used [-Wunused-function] _import_array(void) ^~~~~~~~~~~~~ g++: scipy/spatial/ckdtree/src/fmax.cxx g++ -pthread -shared -Wl,-z,relro -Wl,-z,now -specs=/usr/lib/rpm/redhat/redhat-hardened-ld -Wl,-z,relro -Wl,-z,now -specs=/usr/lib/rpm/redhat/redhat-hardened-ld -shared -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection build/temp.linux-ppc64le-2.7/scipy/spatial/ckdtree.o build/temp.linux-ppc64le-2.7/scipy/spatial/ckdtree/src/query.o build/temp.linux-ppc64le-2.7/scipy/spatial/ckdtree/src/build.o build/temp.linux-ppc64le-2.7/scipy/spatial/ckdtree/src/globals.o build/temp.linux-ppc64le-2.7/scipy/spatial/ckdtree/src/cpp_exc.o build/temp.linux-ppc64le-2.7/scipy/spatial/ckdtree/src/query_pairs.o build/temp.linux-ppc64le-2.7/scipy/spatial/ckdtree/src/count_neighbors.o build/temp.linux-ppc64le-2.7/scipy/spatial/ckdtree/src/query_ball_point.o build/temp.linux-ppc64le-2.7/scipy/spatial/ckdtree/src/query_ball_tree.o build/temp.linux-ppc64le-2.7/scipy/spatial/ckdtree/src/sparse_distances.o build/temp.linux-ppc64le-2.7/scipy/spatial/ckdtree/src/fmax.o -L/usr/lib64 -Lbuild/temp.linux-ppc64le-2.7 -lpython2.7 -o build/lib.linux-ppc64le-2.7/scipy/spatial/ckdtree.so building 'scipy.spatial._distance_wrap' extension compiling C sources C compiler: gcc -pthread -fno-strict-aliasing -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -D_GNU_SOURCE -fPIC -fwrapv -DNDEBUG -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -D_GNU_SOURCE -fPIC -fwrapv -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -fPIC creating build/temp.linux-ppc64le-2.7/scipy/spatial/src compile options: '-I/usr/lib64/python2.7/site-packages/numpy/core/include -I/usr/lib64/python2.7/site-packages/numpy/core/include -I/usr/lib64/python2.7/site-packages/numpy/core/include -I/usr/include/python2.7 -c' gcc: scipy/spatial/src/distance_wrap.c In file included from /usr/include/python2.7/pyconfig.h:6, from /usr/include/python2.7/Python.h:8, from scipy/spatial/src/distance_wrap.c:48: /usr/include/python2.7/pyconfig-64.h:1232: warning: "_POSIX_C_SOURCE" redefined #define _POSIX_C_SOURCE 200112L In file included from /usr/include/bits/libc-header-start.h:33, from /usr/include/stdio.h:27, from scipy/spatial/src/distance_wrap.c:45: /usr/include/features.h:265: note: this is the location of the previous definition # define _POSIX_C_SOURCE 200809L In file included from /usr/include/python2.7/pyconfig.h:6, from /usr/include/python2.7/Python.h:8, from scipy/spatial/src/distance_wrap.c:48: /usr/include/python2.7/pyconfig-64.h:1254: warning: "_XOPEN_SOURCE" redefined #define _XOPEN_SOURCE 600 In file included from /usr/include/bits/libc-header-start.h:33, from /usr/include/stdio.h:27, from scipy/spatial/src/distance_wrap.c:45: /usr/include/features.h:202: note: this is the location of the previous definition # define _XOPEN_SOURCE 700 In file included from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/ndarraytypes.h:1816, from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/ndarrayobject.h:18, from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/arrayobject.h:4, from scipy/spatial/src/distance_wrap.c:49: /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/npy_1_7_deprecated_api.h:15:2: warning: #warning "Using deprecated NumPy API, disable it by " "#defining NPY_NO_DEPRECATED_API NPY_1_7_API_VERSION" [-Wcpp] #warning "Using deprecated NumPy API, disable it by " \ ^~~~~~~ scipy/spatial/src/distance_wrap.c: In function 'cdist_mahalanobis_double_wrap': scipy/spatial/src/distance_wrap.c:136:16: warning: unused variable 'dimbuf' [-Wunused-variable] double *dm, *dimbuf; ^~~~~~ scipy/spatial/src/distance_wrap.c: In function 'pdist_mahalanobis_double_wrap': scipy/spatial/src/distance_wrap.c:337:11: warning: unused variable 'dimbuf' [-Wunused-variable] double *dimbuf, *dm; ^~~~~~ scipy/spatial/src/distance_wrap.c: At top level: scipy/spatial/src/distance_wrap.c:505:32: warning: initialization of 'PyObject * (*)(PyObject *, PyObject *)' {aka 'struct _object * (*)(struct _object *, struct _object *)'} from incompatible pointer type 'PyObject * (*)(PyObject *, PyObject *, PyObject *)' {aka 'struct _object * (*)(struct _object *, struct _object *, struct _object *)'} [-Wincompatible-pointer-types] {"cdist_cosine_double_wrap", cdist_cosine_double_wrap, METH_VARARGS | METH_KEYWORDS}, ^~~~~~~~~~~~~~~~~~~~~~~~ scipy/spatial/src/distance_wrap.c:505:32: note: (near initialization for '_distanceWrapMethods[4].ml_meth') scipy/spatial/src/distance_wrap.c:514:37: warning: initialization of 'PyObject * (*)(PyObject *, PyObject *)' {aka 'struct _object * (*)(struct _object *, struct _object *)'} from incompatible pointer type 'PyObject * (*)(PyObject *, PyObject *, PyObject *)' {aka 'struct _object * (*)(struct _object *, struct _object *, struct _object *)'} [-Wincompatible-pointer-types] {"cdist_mahalanobis_double_wrap", cdist_mahalanobis_double_wrap, METH_VARARGS | METH_KEYWORDS}, ^~~~~~~~~~~~~~~~~~~~~~~~~~~~~ scipy/spatial/src/distance_wrap.c:514:37: note: (near initialization for '_distanceWrapMethods[13].ml_meth') scipy/spatial/src/distance_wrap.c:515:35: warning: initialization of 'PyObject * (*)(PyObject *, PyObject *)' {aka 'struct _object * (*)(struct _object *, struct _object *)'} from incompatible pointer type 'PyObject * (*)(PyObject *, PyObject *, PyObject *)' {aka 'struct _object * (*)(struct _object *, struct _object *, struct _object *)'} [-Wincompatible-pointer-types] {"cdist_minkowski_double_wrap", cdist_minkowski_double_wrap, METH_VARARGS | METH_KEYWORDS}, ^~~~~~~~~~~~~~~~~~~~~~~~~~~ scipy/spatial/src/distance_wrap.c:515:35: note: (near initialization for '_distanceWrapMethods[14].ml_meth') scipy/spatial/src/distance_wrap.c:516:36: warning: initialization of 'PyObject * (*)(PyObject *, PyObject *)' {aka 'struct _object * (*)(struct _object *, struct _object *)'} from incompatible pointer type 'PyObject * (*)(PyObject *, PyObject *, PyObject *)' {aka 'struct _object * (*)(struct _object *, struct _object *, struct _object *)'} [-Wincompatible-pointer-types] {"cdist_wminkowski_double_wrap", cdist_weighted_minkowski_double_wrap, METH_VARARGS | METH_KEYWORDS}, ^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ scipy/spatial/src/distance_wrap.c:516:36: note: (near initialization for '_distanceWrapMethods[15].ml_meth') scipy/spatial/src/distance_wrap.c:519:36: warning: initialization of 'PyObject * (*)(PyObject *, PyObject *)' {aka 'struct _object * (*)(struct _object *, struct _object *)'} from incompatible pointer type 'PyObject * (*)(PyObject *, PyObject *, PyObject *)' {aka 'struct _object * (*)(struct _object *, struct _object *, struct _object *)'} [-Wincompatible-pointer-types] {"cdist_seuclidean_double_wrap", cdist_seuclidean_double_wrap, METH_VARARGS | METH_KEYWORDS}, ^~~~~~~~~~~~~~~~~~~~~~~~~~~~ scipy/spatial/src/distance_wrap.c:519:36: note: (near initialization for '_distanceWrapMethods[18].ml_meth') scipy/spatial/src/distance_wrap.c:527:32: warning: initialization of 'PyObject * (*)(PyObject *, PyObject *)' {aka 'struct _object * (*)(struct _object *, struct _object *)'} from incompatible pointer type 'PyObject * (*)(PyObject *, PyObject *, PyObject *)' {aka 'struct _object * (*)(struct _object *, struct _object *, struct _object *)'} [-Wincompatible-pointer-types] {"pdist_cosine_double_wrap", pdist_cosine_double_wrap, METH_VARARGS | METH_KEYWORDS}, ^~~~~~~~~~~~~~~~~~~~~~~~ scipy/spatial/src/distance_wrap.c:527:32: note: (near initialization for '_distanceWrapMethods[26].ml_meth') scipy/spatial/src/distance_wrap.c:536:37: warning: initialization of 'PyObject * (*)(PyObject *, PyObject *)' {aka 'struct _object * (*)(struct _object *, struct _object *)'} from incompatible pointer type 'PyObject * (*)(PyObject *, PyObject *, PyObject *)' {aka 'struct _object * (*)(struct _object *, struct _object *, struct _object *)'} [-Wincompatible-pointer-types] {"pdist_mahalanobis_double_wrap", pdist_mahalanobis_double_wrap, METH_VARARGS | METH_KEYWORDS}, ^~~~~~~~~~~~~~~~~~~~~~~~~~~~~ scipy/spatial/src/distance_wrap.c:536:37: note: (near initialization for '_distanceWrapMethods[35].ml_meth') scipy/spatial/src/distance_wrap.c:537:35: warning: initialization of 'PyObject * (*)(PyObject *, PyObject *)' {aka 'struct _object * (*)(struct _object *, struct _object *)'} from incompatible pointer type 'PyObject * (*)(PyObject *, PyObject *, PyObject *)' {aka 'struct _object * (*)(struct _object *, struct _object *, struct _object *)'} [-Wincompatible-pointer-types] {"pdist_minkowski_double_wrap", pdist_minkowski_double_wrap, METH_VARARGS | METH_KEYWORDS}, ^~~~~~~~~~~~~~~~~~~~~~~~~~~ scipy/spatial/src/distance_wrap.c:537:35: note: (near initialization for '_distanceWrapMethods[36].ml_meth') scipy/spatial/src/distance_wrap.c:538:36: warning: initialization of 'PyObject * (*)(PyObject *, PyObject *)' {aka 'struct _object * (*)(struct _object *, struct _object *)'} from incompatible pointer type 'PyObject * (*)(PyObject *, PyObject *, PyObject *)' {aka 'struct _object * (*)(struct _object *, struct _object *, struct _object *)'} [-Wincompatible-pointer-types] {"pdist_wminkowski_double_wrap", pdist_weighted_minkowski_double_wrap, METH_VARARGS | METH_KEYWORDS}, ^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ scipy/spatial/src/distance_wrap.c:538:36: note: (near initialization for '_distanceWrapMethods[37].ml_meth') scipy/spatial/src/distance_wrap.c:541:36: warning: initialization of 'PyObject * (*)(PyObject *, PyObject *)' {aka 'struct _object * (*)(struct _object *, struct _object *)'} from incompatible pointer type 'PyObject * (*)(PyObject *, PyObject *, PyObject *)' {aka 'struct _object * (*)(struct _object *, struct _object *, struct _object *)'} [-Wincompatible-pointer-types] {"pdist_seuclidean_double_wrap", pdist_seuclidean_double_wrap, METH_VARARGS | METH_KEYWORDS}, ^~~~~~~~~~~~~~~~~~~~~~~~~~~~ scipy/spatial/src/distance_wrap.c:541:36: note: (near initialization for '_distanceWrapMethods[40].ml_meth') gcc -pthread -shared -Wl,-z,relro -Wl,-z,now -specs=/usr/lib/rpm/redhat/redhat-hardened-ld -Wl,-z,relro -Wl,-z,now -specs=/usr/lib/rpm/redhat/redhat-hardened-ld -shared -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection build/temp.linux-ppc64le-2.7/scipy/spatial/src/distance_wrap.o -L/usr/lib64/python2.7/site-packages/numpy/core/lib -L/usr/lib64 -Lbuild/temp.linux-ppc64le-2.7 -lnpymath -lm -lpython2.7 -o build/lib.linux-ppc64le-2.7/scipy/spatial/_distance_wrap.so building 'scipy.spatial._voronoi' extension compiling C sources C compiler: gcc -pthread -fno-strict-aliasing -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -D_GNU_SOURCE -fPIC -fwrapv -DNDEBUG -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -D_GNU_SOURCE -fPIC -fwrapv -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -fPIC compile options: '-I/usr/lib64/python2.7/site-packages/numpy/core/include -I/usr/include/python2.7 -c' gcc: scipy/spatial/_voronoi.c In file included from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/ndarraytypes.h:1816, from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/ndarrayobject.h:18, from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/arrayobject.h:4, from scipy/spatial/_voronoi.c:435: /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/npy_1_7_deprecated_api.h:15:2: warning: #warning "Using deprecated NumPy API, disable it by " "#defining NPY_NO_DEPRECATED_API NPY_1_7_API_VERSION" [-Wcpp] #warning "Using deprecated NumPy API, disable it by " \ ^~~~~~~ scipy/spatial/_voronoi.c: In function '__pyx_pw_5scipy_7spatial_8_voronoi_1sort_vertices_of_regions': scipy/spatial/_voronoi.c:2862:14: warning: '__pyx_v_current_vertex' may be used uninitialized in this function [-Wmaybe-uninitialized] if (__pyx_t_16) { ^ scipy/spatial/_voronoi.c:2344:12: note: '__pyx_v_current_vertex' was declared here npy_intp __pyx_v_current_vertex; ^~~~~~~~~~~~~~~~~~~~~~ gcc -pthread -shared -Wl,-z,relro -Wl,-z,now -specs=/usr/lib/rpm/redhat/redhat-hardened-ld -Wl,-z,relro -Wl,-z,now -specs=/usr/lib/rpm/redhat/redhat-hardened-ld -shared -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection build/temp.linux-ppc64le-2.7/scipy/spatial/_voronoi.o -L/usr/lib64 -Lbuild/temp.linux-ppc64le-2.7 -lpython2.7 -o build/lib.linux-ppc64le-2.7/scipy/spatial/_voronoi.so building 'scipy.spatial._hausdorff' extension compiling C sources C compiler: gcc -pthread -fno-strict-aliasing -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -D_GNU_SOURCE -fPIC -fwrapv -DNDEBUG -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -D_GNU_SOURCE -fPIC -fwrapv -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -fPIC compile options: '-I/usr/lib64/python2.7/site-packages/numpy/core/include -I/usr/include/python2.7 -c' gcc: scipy/spatial/_hausdorff.c In file included from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/ndarraytypes.h:1816, from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/ndarrayobject.h:18, from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/arrayobject.h:4, from scipy/spatial/_hausdorff.c:435: /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/npy_1_7_deprecated_api.h:15:2: warning: #warning "Using deprecated NumPy API, disable it by " "#defining NPY_NO_DEPRECATED_API NPY_1_7_API_VERSION" [-Wcpp] #warning "Using deprecated NumPy API, disable it by " \ ^~~~~~~ gcc -pthread -shared -Wl,-z,relro -Wl,-z,now -specs=/usr/lib/rpm/redhat/redhat-hardened-ld -Wl,-z,relro -Wl,-z,now -specs=/usr/lib/rpm/redhat/redhat-hardened-ld -shared -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection build/temp.linux-ppc64le-2.7/scipy/spatial/_hausdorff.o -L/usr/lib64 -Lbuild/temp.linux-ppc64le-2.7 -lpython2.7 -o build/lib.linux-ppc64le-2.7/scipy/spatial/_hausdorff.so building 'scipy.special.specfun' extension compiling C sources C compiler: gcc -pthread -fno-strict-aliasing -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -D_GNU_SOURCE -fPIC -fwrapv -DNDEBUG -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -D_GNU_SOURCE -fPIC -fwrapv -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -fPIC creating build/temp.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/special creating build/temp.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/special compile options: '-Ibuild/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/special -I/usr/lib64/python2.7/site-packages/numpy/core/include -I/usr/include/python2.7 -c' gcc: build/src.linux-ppc64le-2.7/scipy/special/specfunmodule.c In file included from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/ndarraytypes.h:1816, from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/ndarrayobject.h:18, from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/arrayobject.h:4, from build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/special/fortranobject.h:13, from build/src.linux-ppc64le-2.7/scipy/special/specfunmodule.c:16: /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/npy_1_7_deprecated_api.h:15:2: warning: #warning "Using deprecated NumPy API, disable it by " "#defining NPY_NO_DEPRECATED_API NPY_1_7_API_VERSION" [-Wcpp] #warning "Using deprecated NumPy API, disable it by " \ ^~~~~~~ build/src.linux-ppc64le-2.7/scipy/special/specfunmodule.c:110:12: warning: 'f2py_size' defined but not used [-Wunused-function] static int f2py_size(PyArrayObject* var, ...) ^~~~~~~~~ gcc: build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/special/fortranobject.c In file included from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/ndarraytypes.h:1816, from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/ndarrayobject.h:18, from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/arrayobject.h:4, from build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/special/fortranobject.h:13, from build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/special/fortranobject.c:2: /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/npy_1_7_deprecated_api.h:15:2: warning: #warning "Using deprecated NumPy API, disable it by " "#defining NPY_NO_DEPRECATED_API NPY_1_7_API_VERSION" [-Wcpp] #warning "Using deprecated NumPy API, disable it by " \ ^~~~~~~ /usr/bin/gfortran -Wall -g -Wl,-z,relro -Wl,-z,now -specs=/usr/lib/rpm/redhat/redhat-hardened-ld -shared build/temp.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/special/specfunmodule.o build/temp.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/special/fortranobject.o -L/usr/lib/gcc/ppc64le-redhat-linux/8 -L/usr/lib/gcc/ppc64le-redhat-linux/8 -L/usr/lib64 -Lbuild/temp.linux-ppc64le-2.7 -lsc_specfun -lpython2.7 -lgfortran -o build/lib.linux-ppc64le-2.7/scipy/special/specfun.so building 'scipy.special._ufuncs' extension compiling C sources C compiler: gcc -pthread -fno-strict-aliasing -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -D_GNU_SOURCE -fPIC -fwrapv -DNDEBUG -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -D_GNU_SOURCE -fPIC -fwrapv -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -fPIC compile options: '-DHAVE_CBLAS -I/builddir/build/BUILD/scipy-1.0.0/scipy/special -I/usr/lib64/python2.7/site-packages/numpy/core/include -I/usr/include/python2.7 -I/builddir/build/BUILD/scipy-1.0.0/scipy/special/c_misc -I/usr/lib64/python2.7/site-packages/numpy/core/include -I/usr/lib64/python2.7/site-packages/numpy/core/include -I/usr/lib64/python2.7/site-packages/numpy/core/include -I/usr/include/python2.7 -c' gcc: scipy/special/_ufuncs.c In file included from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/ndarraytypes.h:1816, from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/ndarrayobject.h:18, from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/arrayobject.h:4, from scipy/special/_ufuncs.c:437: /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/npy_1_7_deprecated_api.h:15:2: warning: #warning "Using deprecated NumPy API, disable it by " "#defining NPY_NO_DEPRECATED_API NPY_1_7_API_VERSION" [-Wcpp] #warning "Using deprecated NumPy API, disable it by " \ ^~~~~~~ In file included from scipy/special/_ufuncs.c:449: scipy/special/c_misc/double2.h:208:13: warning: 'double2_div' defined but not used [-Wunused-function] static void double2_div(double2_t *a, double2_t *b, double2_t *c) ^~~~~~~~~~~ scipy/special/_ufuncs.c: In function '__pyx_f_5scipy_7special_7_cunity_cexpm1': scipy/special/_ufuncs.c:21647:31: warning: '__pyx_v_ezr' may be used uninitialized in this function [-Wmaybe-uninitialized] __pyx_v_y = ((__pyx_v_ezr + 1.0) * sin(__pyx_v_zi)); ~~~~~~~~~~~~~^~~~~~ scipy/special/_ufuncs.c: In function '__pyx_f_5scipy_7special_17_spherical_bessel_spherical_jn_real': scipy/special/_ufuncs.c:22287:10: warning: '__pyx_v_sn' may be used uninitialized in this function [-Wmaybe-uninitialized] return __pyx_r; ^~~~~~~ scipy/special/_ufuncs.c: In function '__pyx_f_5scipy_7special_17_spherical_bessel_spherical_jn_d_real': scipy/special/_ufuncs.c:24102:13: warning: '__pyx_r' may be used uninitialized in this function [-Wmaybe-uninitialized] __pyx_r = (__pyx_f_5scipy_7special_17_spherical_bessel_spherical_jn_real((__pyx_v_n - 1), __pyx_v_x) - (((__pyx_v_n + 1) * __pyx_f_5scipy_7special_17_spherical_bessel_spherical_jn_real(__pyx_v_n, __pyx_v_x)) / __pyx_v_x)); ~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ scipy/special/_ufuncs.c:24102:126: warning: '__pyx_v_sn' may be used uninitialized in this function [-Wmaybe-uninitialized] __pyx_r = (__pyx_f_5scipy_7special_17_spherical_bessel_spherical_jn_real((__pyx_v_n - 1), __pyx_v_x) - (((__pyx_v_n + 1) * __pyx_f_5scipy_7special_17_spherical_bessel_spherical_jn_real(__pyx_v_n, __pyx_v_x)) / __pyx_v_x)); ~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ scipy/special/_ufuncs.c: In function '__pyx_f_5scipy_7special_17_spherical_bessel_spherical_yn_real.part.23': scipy/special/_ufuncs.c:22581:10: warning: '__pyx_v_sn' may be used uninitialized in this function [-Wmaybe-uninitialized] double __pyx_v_sn; ^~~~~~~~~~ scipy/special/_ufuncs.c: In function '__pyx_f_5scipy_7special_17_spherical_bessel_spherical_yn_real': scipy/special/_ufuncs.c:22915:10: warning: '__pyx_v_sn' may be used uninitialized in this function [-Wmaybe-uninitialized] return __pyx_r; ^~~~~~~ scipy/special/_ufuncs.c: In function '__pyx_f_5scipy_7special_17_spherical_bessel_spherical_yn_d_real': scipy/special/_ufuncs.c:24250:13: warning: '__pyx_r' may be used uninitialized in this function [-Wmaybe-uninitialized] __pyx_r = (__pyx_f_5scipy_7special_17_spherical_bessel_spherical_yn_real((__pyx_v_n - 1), __pyx_v_x) - (((__pyx_v_n + 1) * __pyx_f_5scipy_7special_17_spherical_bessel_spherical_yn_real(__pyx_v_n, __pyx_v_x)) / __pyx_v_x)); ~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ scipy/special/_ufuncs.c:24250:126: warning: '__pyx_v_sn' may be used uninitialized in this function [-Wmaybe-uninitialized] __pyx_r = (__pyx_f_5scipy_7special_17_spherical_bessel_spherical_yn_real((__pyx_v_n - 1), __pyx_v_x) - (((__pyx_v_n + 1) * __pyx_f_5scipy_7special_17_spherical_bessel_spherical_yn_real(__pyx_v_n, __pyx_v_x)) / __pyx_v_x)); ~~~~~~~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ scipy/special/_ufuncs.c: In function '__pyx_f_5scipy_7special_11_ellip_harm_lame_coefficients': scipy/special/_ufuncs.c:19586:3: warning: '__pyx_v_t' may be used uninitialized in this function [-Wmaybe-uninitialized] switch (__pyx_v_t) { ^~~~~~ scipy/special/_ufuncs.c: In function '__pyx_f_5scipy_7special_11_ellip_harm_ellip_harmonic': scipy/special/_ufuncs.c:20374:14: warning: '__pyx_v_psi' may be used uninitialized in this function [-Wmaybe-uninitialized] __pyx_v_pp = (__pyx_v_pp * __pyx_v_psi); ~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~ scipy/special/_ufuncs.c:20176:10: note: '__pyx_v_psi' was declared here double __pyx_v_psi; ^~~~~~~~~~~ scipy/special/_ufuncs.c:20354:18: warning: '__pyx_v_size' may be used uninitialized in this function [-Wmaybe-uninitialized] for (__pyx_t_4 = (__pyx_v_size - 2); __pyx_t_4 > -1L; __pyx_t_4-=1) { ~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~ scipy/special/_ufuncs.c:20170:7: note: '__pyx_v_size' was declared here int __pyx_v_size; ^~~~~~~~~~~~ scipy/special/_ufuncs.c: In function '__pyx_f_5scipy_7special_7_legacy_ellip_harmonic_unsafe': scipy/special/_ufuncs.c:20374:14: warning: '__pyx_v_psi' may be used uninitialized in this function [-Wmaybe-uninitialized] __pyx_v_pp = (__pyx_v_pp * __pyx_v_psi); ~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~ scipy/special/_ufuncs.c:20176:10: note: '__pyx_v_psi' was declared here double __pyx_v_psi; ^~~~~~~~~~~ scipy/special/_ufuncs.c:20354:18: warning: '__pyx_v_size' may be used uninitialized in this function [-Wmaybe-uninitialized] for (__pyx_t_4 = (__pyx_v_size - 2); __pyx_t_4 > -1L; __pyx_t_4-=1) { ~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~ scipy/special/_ufuncs.c:20170:7: note: '__pyx_v_size' was declared here int __pyx_v_size; ^~~~~~~~~~~~ gcc: scipy/special/cdf_wrappers.c gcc: scipy/special/specfun_wrappers.c gcc: scipy/special/amos_wrappers.c gcc: build/src.linux-ppc64le-2.7/scipy/special/_logit.c gcc: scipy/special/sf_error.c In file included from /usr/include/python2.7/pyconfig.h:6, from /usr/include/python2.7/Python.h:8, from scipy/special/sf_error.c:4: /usr/include/python2.7/pyconfig-64.h:1232: warning: "_POSIX_C_SOURCE" redefined #define _POSIX_C_SOURCE 200112L In file included from /usr/include/bits/libc-header-start.h:33, from /usr/include/stdlib.h:25, from scipy/special/sf_error.c:1: /usr/include/features.h:265: note: this is the location of the previous definition # define _POSIX_C_SOURCE 200809L In file included from /usr/include/python2.7/pyconfig.h:6, from /usr/include/python2.7/Python.h:8, from scipy/special/sf_error.c:4: /usr/include/python2.7/pyconfig-64.h:1254: warning: "_XOPEN_SOURCE" redefined #define _XOPEN_SOURCE 600 In file included from /usr/include/bits/libc-header-start.h:33, from /usr/include/stdlib.h:25, from scipy/special/sf_error.c:1: /usr/include/features.h:202: note: this is the location of the previous definition # define _XOPEN_SOURCE 700 /usr/bin/gfortran -Wall -g -Wl,-z,relro -Wl,-z,now -specs=/usr/lib/rpm/redhat/redhat-hardened-ld -shared build/temp.linux-ppc64le-2.7/scipy/special/_ufuncs.o build/temp.linux-ppc64le-2.7/scipy/special/sf_error.o build/temp.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/special/_logit.o build/temp.linux-ppc64le-2.7/scipy/special/amos_wrappers.o build/temp.linux-ppc64le-2.7/scipy/special/cdf_wrappers.o build/temp.linux-ppc64le-2.7/scipy/special/specfun_wrappers.o -L/usr/lib64 -L/usr/lib64/python2.7/site-packages/numpy/core/lib -L/usr/lib/gcc/ppc64le-redhat-linux/8 -L/usr/lib/gcc/ppc64le-redhat-linux/8 -L/usr/lib64 -Lbuild/temp.linux-ppc64le-2.7 -Wl,-rpath="/usr/lib64" -lopenblasp -lopenblas -lsc_amos -lsc_c_misc -lsc_cephes -lsc_mach -lsc_cdf -lsc_specfun -lnpymath -lm -lpython2.7 -lgfortran -o build/lib.linux-ppc64le-2.7/scipy/special/_ufuncs.so building 'scipy.special._ufuncs_cxx' extension compiling C sources C compiler: gcc -pthread -fno-strict-aliasing -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -D_GNU_SOURCE -fPIC -fwrapv -DNDEBUG -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -D_GNU_SOURCE -fPIC -fwrapv -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -fPIC compile options: '-I/builddir/build/BUILD/scipy-1.0.0/scipy/special -I/usr/lib64/python2.7/site-packages/numpy/core/include -I/usr/lib64/python2.7/site-packages/numpy/core/include -I/usr/include/python2.7 -c' gcc: scipy/special/sf_error.c In file included from /usr/include/python2.7/pyconfig.h:6, from /usr/include/python2.7/Python.h:8, from scipy/special/sf_error.c:4: /usr/include/python2.7/pyconfig-64.h:1232: warning: "_POSIX_C_SOURCE" redefined #define _POSIX_C_SOURCE 200112L In file included from /usr/include/bits/libc-header-start.h:33, from /usr/include/stdlib.h:25, from scipy/special/sf_error.c:1: /usr/include/features.h:265: note: this is the location of the previous definition # define _POSIX_C_SOURCE 200809L In file included from /usr/include/python2.7/pyconfig.h:6, from /usr/include/python2.7/Python.h:8, from scipy/special/sf_error.c:4: /usr/include/python2.7/pyconfig-64.h:1254: warning: "_XOPEN_SOURCE" redefined #define _XOPEN_SOURCE 600 In file included from /usr/include/bits/libc-header-start.h:33, from /usr/include/stdlib.h:25, from scipy/special/sf_error.c:1: /usr/include/features.h:202: note: this is the location of the previous definition # define _XOPEN_SOURCE 700 compiling C++ sources C compiler: g++ -pthread -fno-strict-aliasing -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -D_GNU_SOURCE -fPIC -fwrapv -DNDEBUG -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -D_GNU_SOURCE -fPIC -fwrapv -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -fPIC compile options: '-I/builddir/build/BUILD/scipy-1.0.0/scipy/special -I/usr/lib64/python2.7/site-packages/numpy/core/include -I/usr/lib64/python2.7/site-packages/numpy/core/include -I/usr/include/python2.7 -c' g++: scipy/special/wright.cc In file included from /usr/include/python2.7/pyconfig.h:6, from /usr/include/python2.7/Python.h:8, from scipy/special/wright.cc:75: /usr/include/python2.7/pyconfig-64.h:1232: warning: "_POSIX_C_SOURCE" redefined #define _POSIX_C_SOURCE 200112L In file included from /usr/include/c++/8/ppc64le-redhat-linux/bits/os_defines.h:39, from /usr/include/c++/8/ppc64le-redhat-linux/bits/c++config.h:508, from /usr/include/c++/8/complex:41, from scipy/special/wright.hh:4, from scipy/special/wright.cc:1: /usr/include/features.h:265: note: this is the location of the previous definition # define _POSIX_C_SOURCE 200809L In file included from /usr/include/python2.7/pyconfig.h:6, from /usr/include/python2.7/Python.h:8, from scipy/special/wright.cc:75: /usr/include/python2.7/pyconfig-64.h:1254: warning: "_XOPEN_SOURCE" redefined #define _XOPEN_SOURCE 600 In file included from /usr/include/c++/8/ppc64le-redhat-linux/bits/os_defines.h:39, from /usr/include/c++/8/ppc64le-redhat-linux/bits/c++config.h:508, from /usr/include/c++/8/complex:41, from scipy/special/wright.hh:4, from scipy/special/wright.cc:1: /usr/include/features.h:202: note: this is the location of the previous definition # define _XOPEN_SOURCE 700 In file included from scipy/special/_round.h:10, from scipy/special/wright.cc:80: scipy/special/c_misc/double2.h:235:15: warning: 'double double2_double(double2_t*)' defined but not used [-Wunused-function] static double double2_double(double2_t *a) ^~~~~~~~~~~~~~ scipy/special/c_misc/double2.h:208:13: warning: 'void double2_div(double2_t*, double2_t*, double2_t*)' defined but not used [-Wunused-function] static void double2_div(double2_t *a, double2_t *b, double2_t *c) ^~~~~~~~~~~ g++: scipy/special/_ufuncs_cxx.cxx In file included from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/ndarraytypes.h:1816, from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/ndarrayobject.h:18, from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/arrayobject.h:4, from scipy/special/_ufuncs_cxx.cxx:452: /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/npy_1_7_deprecated_api.h:15:2: warning: #warning "Using deprecated NumPy API, disable it by " "#defining NPY_NO_DEPRECATED_API NPY_1_7_API_VERSION" [-Wcpp] #warning "Using deprecated NumPy API, disable it by " \ ^~~~~~~ g++: scipy/special/Faddeeva.cc In file included from /usr/include/python2.7/pyconfig.h:6, from /usr/include/python2.7/Python.h:8, from scipy/special/Faddeeva.cc:120: /usr/include/python2.7/pyconfig-64.h:1232: warning: "_POSIX_C_SOURCE" redefined #define _POSIX_C_SOURCE 200112L In file included from /usr/include/c++/8/ppc64le-redhat-linux/bits/os_defines.h:39, from /usr/include/c++/8/ppc64le-redhat-linux/bits/c++config.h:508, from /usr/include/c++/8/complex:41, from scipy/special/Faddeeva.hh:30, from scipy/special/Faddeeva.cc:23: /usr/include/features.h:265: note: this is the location of the previous definition # define _POSIX_C_SOURCE 200809L In file included from /usr/include/python2.7/pyconfig.h:6, from /usr/include/python2.7/Python.h:8, from scipy/special/Faddeeva.cc:120: /usr/include/python2.7/pyconfig-64.h:1254: warning: "_XOPEN_SOURCE" redefined #define _XOPEN_SOURCE 600 In file included from /usr/include/c++/8/ppc64le-redhat-linux/bits/os_defines.h:39, from /usr/include/c++/8/ppc64le-redhat-linux/bits/c++config.h:508, from /usr/include/c++/8/complex:41, from scipy/special/Faddeeva.hh:30, from scipy/special/Faddeeva.cc:23: /usr/include/features.h:202: note: this is the location of the previous definition # define _XOPEN_SOURCE 700 g++: scipy/special/_faddeeva.cxx In file included from /usr/include/python2.7/pyconfig.h:6, from /usr/include/python2.7/Python.h:8, from scipy/special/_faddeeva.h:13, from scipy/special/_faddeeva.cxx:3: /usr/include/python2.7/pyconfig-64.h:1232: warning: "_POSIX_C_SOURCE" redefined #define _POSIX_C_SOURCE 200112L In file included from /usr/include/c++/8/ppc64le-redhat-linux/bits/os_defines.h:39, from /usr/include/c++/8/ppc64le-redhat-linux/bits/c++config.h:508, from /usr/include/c++/8/complex:41, from scipy/special/_faddeeva.cxx:1: /usr/include/features.h:265: note: this is the location of the previous definition # define _POSIX_C_SOURCE 200809L In file included from /usr/include/python2.7/pyconfig.h:6, from /usr/include/python2.7/Python.h:8, from scipy/special/_faddeeva.h:13, from scipy/special/_faddeeva.cxx:3: /usr/include/python2.7/pyconfig-64.h:1254: warning: "_XOPEN_SOURCE" redefined #define _XOPEN_SOURCE 600 In file included from /usr/include/c++/8/ppc64le-redhat-linux/bits/os_defines.h:39, from /usr/include/c++/8/ppc64le-redhat-linux/bits/c++config.h:508, from /usr/include/c++/8/complex:41, from scipy/special/_faddeeva.cxx:1: /usr/include/features.h:202: note: this is the location of the previous definition # define _XOPEN_SOURCE 700 g++: scipy/special/_wright.cxx In file included from /usr/include/python2.7/pyconfig.h:6, from /usr/include/python2.7/Python.h:8, from scipy/special/_wright.h:13, from scipy/special/_wright.cxx:3: /usr/include/python2.7/pyconfig-64.h:1232: warning: "_POSIX_C_SOURCE" redefined #define _POSIX_C_SOURCE 200112L In file included from /usr/include/c++/8/ppc64le-redhat-linux/bits/os_defines.h:39, from /usr/include/c++/8/ppc64le-redhat-linux/bits/c++config.h:508, from /usr/include/c++/8/complex:41, from scipy/special/_wright.cxx:1: /usr/include/features.h:265: note: this is the location of the previous definition # define _POSIX_C_SOURCE 200809L In file included from /usr/include/python2.7/pyconfig.h:6, from /usr/include/python2.7/Python.h:8, from scipy/special/_wright.h:13, from scipy/special/_wright.cxx:3: /usr/include/python2.7/pyconfig-64.h:1254: warning: "_XOPEN_SOURCE" redefined #define _XOPEN_SOURCE 600 In file included from /usr/include/c++/8/ppc64le-redhat-linux/bits/os_defines.h:39, from /usr/include/c++/8/ppc64le-redhat-linux/bits/c++config.h:508, from /usr/include/c++/8/complex:41, from scipy/special/_wright.cxx:1: /usr/include/features.h:202: note: this is the location of the previous definition # define _XOPEN_SOURCE 700 g++ -pthread -shared -Wl,-z,relro -Wl,-z,now -specs=/usr/lib/rpm/redhat/redhat-hardened-ld -Wl,-z,relro -Wl,-z,now -specs=/usr/lib/rpm/redhat/redhat-hardened-ld -shared -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection build/temp.linux-ppc64le-2.7/scipy/special/sf_error.o build/temp.linux-ppc64le-2.7/scipy/special/_ufuncs_cxx.o build/temp.linux-ppc64le-2.7/scipy/special/_faddeeva.o build/temp.linux-ppc64le-2.7/scipy/special/Faddeeva.o build/temp.linux-ppc64le-2.7/scipy/special/_wright.o build/temp.linux-ppc64le-2.7/scipy/special/wright.o -L/usr/lib64/python2.7/site-packages/numpy/core/lib -L/usr/lib64 -Lbuild/temp.linux-ppc64le-2.7 -lnpymath -lm -lpython2.7 -o build/lib.linux-ppc64le-2.7/scipy/special/_ufuncs_cxx.so building 'scipy.special._ellip_harm_2' extension compiling C sources C compiler: gcc -pthread -fno-strict-aliasing -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -D_GNU_SOURCE -fPIC -fwrapv -DNDEBUG -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -D_GNU_SOURCE -fPIC -fwrapv -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -fPIC compile options: '-DHAVE_CBLAS -I/usr/lib64/python2.7/site-packages/numpy/core/include -I/usr/include/python2.7 -c' gcc: scipy/special/sf_error.c In file included from /usr/include/python2.7/pyconfig.h:6, from /usr/include/python2.7/Python.h:8, from scipy/special/sf_error.c:4: /usr/include/python2.7/pyconfig-64.h:1232: warning: "_POSIX_C_SOURCE" redefined #define _POSIX_C_SOURCE 200112L In file included from /usr/include/bits/libc-header-start.h:33, from /usr/include/stdlib.h:25, from scipy/special/sf_error.c:1: /usr/include/features.h:265: note: this is the location of the previous definition # define _POSIX_C_SOURCE 200809L In file included from /usr/include/python2.7/pyconfig.h:6, from /usr/include/python2.7/Python.h:8, from scipy/special/sf_error.c:4: /usr/include/python2.7/pyconfig-64.h:1254: warning: "_XOPEN_SOURCE" redefined #define _XOPEN_SOURCE 600 In file included from /usr/include/bits/libc-header-start.h:33, from /usr/include/stdlib.h:25, from scipy/special/sf_error.c:1: /usr/include/features.h:202: note: this is the location of the previous definition # define _XOPEN_SOURCE 700 gcc: scipy/special/_ellip_harm_2.c In file included from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/ndarraytypes.h:1816, from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/ndarrayobject.h:18, from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/arrayobject.h:4, from scipy/special/_ellip_harm_2.c:439: /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/npy_1_7_deprecated_api.h:15:2: warning: #warning "Using deprecated NumPy API, disable it by " "#defining NPY_NO_DEPRECATED_API NPY_1_7_API_VERSION" [-Wcpp] #warning "Using deprecated NumPy API, disable it by " \ ^~~~~~~ scipy/special/_ellip_harm_2.c: In function '__pyx_f_5scipy_7special_13_ellip_harm_2__F_integrand3': scipy/special/_ellip_harm_2.c:5455:14: warning: '__pyx_v_psi' may be used uninitialized in this function [-Wmaybe-uninitialized] __pyx_v_pp = (__pyx_v_pp * __pyx_v_psi); ~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~ scipy/special/_ellip_harm_2.c:5257:10: note: '__pyx_v_psi' was declared here double __pyx_v_psi; ^~~~~~~~~~~ scipy/special/_ellip_harm_2.c:5435:18: warning: '__pyx_v_size' may be used uninitialized in this function [-Wmaybe-uninitialized] for (__pyx_t_4 = (__pyx_v_size - 2); __pyx_t_4 > -1L; __pyx_t_4-=1) { ~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~ scipy/special/_ellip_harm_2.c:5251:7: note: '__pyx_v_size' was declared here int __pyx_v_size; ^~~~~~~~~~~~ scipy/special/_ellip_harm_2.c: In function '__pyx_f_5scipy_7special_13_ellip_harm_2__F_integrand1': scipy/special/_ellip_harm_2.c:5455:14: warning: '__pyx_v_psi' may be used uninitialized in this function [-Wmaybe-uninitialized] __pyx_v_pp = (__pyx_v_pp * __pyx_v_psi); ~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~ scipy/special/_ellip_harm_2.c:5257:10: note: '__pyx_v_psi' was declared here double __pyx_v_psi; ^~~~~~~~~~~ scipy/special/_ellip_harm_2.c:5435:18: warning: '__pyx_v_size' may be used uninitialized in this function [-Wmaybe-uninitialized] for (__pyx_t_4 = (__pyx_v_size - 2); __pyx_t_4 > -1L; __pyx_t_4-=1) { ~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~ scipy/special/_ellip_harm_2.c:5251:7: note: '__pyx_v_size' was declared here int __pyx_v_size; ^~~~~~~~~~~~ scipy/special/_ellip_harm_2.c: In function '__pyx_f_5scipy_7special_13_ellip_harm_2__F_integrand4': scipy/special/_ellip_harm_2.c:5455:14: warning: '__pyx_v_psi' may be used uninitialized in this function [-Wmaybe-uninitialized] __pyx_v_pp = (__pyx_v_pp * __pyx_v_psi); ~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~ scipy/special/_ellip_harm_2.c:5257:10: note: '__pyx_v_psi' was declared here double __pyx_v_psi; ^~~~~~~~~~~ scipy/special/_ellip_harm_2.c:5435:18: warning: '__pyx_v_size' may be used uninitialized in this function [-Wmaybe-uninitialized] for (__pyx_t_4 = (__pyx_v_size - 2); __pyx_t_4 > -1L; __pyx_t_4-=1) { ~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~ scipy/special/_ellip_harm_2.c:5251:7: note: '__pyx_v_size' was declared here int __pyx_v_size; ^~~~~~~~~~~~ scipy/special/_ellip_harm_2.c: In function '__pyx_f_5scipy_7special_13_ellip_harm_2__F_integrand2': scipy/special/_ellip_harm_2.c:5455:14: warning: '__pyx_v_psi' may be used uninitialized in this function [-Wmaybe-uninitialized] __pyx_v_pp = (__pyx_v_pp * __pyx_v_psi); ~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~ scipy/special/_ellip_harm_2.c:5257:10: note: '__pyx_v_psi' was declared here double __pyx_v_psi; ^~~~~~~~~~~ scipy/special/_ellip_harm_2.c:5435:18: warning: '__pyx_v_size' may be used uninitialized in this function [-Wmaybe-uninitialized] for (__pyx_t_4 = (__pyx_v_size - 2); __pyx_t_4 > -1L; __pyx_t_4-=1) { ~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~ scipy/special/_ellip_harm_2.c:5251:7: note: '__pyx_v_size' was declared here int __pyx_v_size; ^~~~~~~~~~~~ scipy/special/_ellip_harm_2.c: In function '__pyx_f_5scipy_7special_13_ellip_harm_2__F_integrand': scipy/special/_ellip_harm_2.c:5455:14: warning: '__pyx_v_psi' may be used uninitialized in this function [-Wmaybe-uninitialized] __pyx_v_pp = (__pyx_v_pp * __pyx_v_psi); ~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~ scipy/special/_ellip_harm_2.c:5257:10: note: '__pyx_v_psi' was declared here double __pyx_v_psi; ^~~~~~~~~~~ scipy/special/_ellip_harm_2.c:5435:18: warning: '__pyx_v_size' may be used uninitialized in this function [-Wmaybe-uninitialized] for (__pyx_t_4 = (__pyx_v_size - 2); __pyx_t_4 > -1L; __pyx_t_4-=1) { ~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~ scipy/special/_ellip_harm_2.c:5251:7: note: '__pyx_v_size' was declared here int __pyx_v_size; ^~~~~~~~~~~~ scipy/special/_ellip_harm_2.c: In function '__pyx_f_5scipy_7special_11_ellip_harm_lame_coefficients.constprop': scipy/special/_ellip_harm_2.c:4667:3: warning: '__pyx_v_t' may be used uninitialized in this function [-Wmaybe-uninitialized] switch (__pyx_v_t) { ^~~~~~ scipy/special/_ellip_harm_2.c: In function '__pyx_pw_5scipy_7special_13_ellip_harm_2_1_ellipsoid': scipy/special/_ellip_harm_2.c:5455:14: warning: '__pyx_v_psi' may be used uninitialized in this function [-Wmaybe-uninitialized] __pyx_v_pp = (__pyx_v_pp * __pyx_v_psi); ~~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~~~~~~~~~ scipy/special/_ellip_harm_2.c:5257:10: note: '__pyx_v_psi' was declared here double __pyx_v_psi; ^~~~~~~~~~~ scipy/special/_ellip_harm_2.c:5435:18: warning: '__pyx_v_size' may be used uninitialized in this function [-Wmaybe-uninitialized] for (__pyx_t_4 = (__pyx_v_size - 2); __pyx_t_4 > -1L; __pyx_t_4-=1) { ~~~~~~~~~~^~~~~~~~~~~~~~~~~~~~ scipy/special/_ellip_harm_2.c:5251:7: note: '__pyx_v_size' was declared here int __pyx_v_size; ^~~~~~~~~~~~ gcc -pthread -shared -Wl,-z,relro -Wl,-z,now -specs=/usr/lib/rpm/redhat/redhat-hardened-ld -Wl,-z,relro -Wl,-z,now -specs=/usr/lib/rpm/redhat/redhat-hardened-ld -shared -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection build/temp.linux-ppc64le-2.7/scipy/special/_ellip_harm_2.o build/temp.linux-ppc64le-2.7/scipy/special/sf_error.o -L/usr/lib64 -L/usr/lib64 -Lbuild/temp.linux-ppc64le-2.7 -lopenblasp -lopenblas -lpython2.7 -o build/lib.linux-ppc64le-2.7/scipy/special/_ellip_harm_2.so building 'scipy.special.cython_special' extension compiling C sources C compiler: gcc -pthread -fno-strict-aliasing -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -D_GNU_SOURCE -fPIC -fwrapv -DNDEBUG -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -D_GNU_SOURCE -fPIC -fwrapv -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -fPIC compile options: '-DHAVE_CBLAS -I/builddir/build/BUILD/scipy-1.0.0/scipy/special -I/usr/lib64/python2.7/site-packages/numpy/core/include -I/usr/include/python2.7 -I/builddir/build/BUILD/scipy-1.0.0/scipy/special/c_misc -I/usr/lib64/python2.7/site-packages/numpy/core/include -I/usr/lib64/python2.7/site-packages/numpy/core/include -I/usr/lib64/python2.7/site-packages/numpy/core/include -I/usr/include/python2.7 -c' gcc: scipy/special/sf_error.c In file included from /usr/include/python2.7/pyconfig.h:6, from /usr/include/python2.7/Python.h:8, from scipy/special/sf_error.c:4: /usr/include/python2.7/pyconfig-64.h:1232: warning: "_POSIX_C_SOURCE" redefined #define _POSIX_C_SOURCE 200112L In file included from /usr/include/bits/libc-header-start.h:33, from /usr/include/stdlib.h:25, from scipy/special/sf_error.c:1: /usr/include/features.h:265: note: this is the location of the previous definition # define _POSIX_C_SOURCE 200809L In file included from /usr/include/python2.7/pyconfig.h:6, from /usr/include/python2.7/Python.h:8, from scipy/special/sf_error.c:4: /usr/include/python2.7/pyconfig-64.h:1254: warning: "_XOPEN_SOURCE" redefined #define _XOPEN_SOURCE 600 In file included from /usr/include/bits/libc-header-start.h:33, from /usr/include/stdlib.h:25, from scipy/special/sf_error.c:1: /usr/include/features.h:202: note: this is the location of the previous definition # define _XOPEN_SOURCE 700 gcc: scipy/special/cython_special.c In file included from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/ndarraytypes.h:1816, from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/ndarrayobject.h:18, from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/arrayobject.h:4, from scipy/special/cython_special.c:435: /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/npy_1_7_deprecated_api.h:15:2: warning: #warning "Using deprecated NumPy API, disable it by " "#defining NPY_NO_DEPRECATED_API NPY_1_7_API_VERSION" [-Wcpp] #warning "Using deprecated NumPy API, disable it by " \ ^~~~~~~ In file included from scipy/special/cython_special.c:448: scipy/special/c_misc/double2.h:208:13: warning: 'double2_div' defined but not used [-Wunused-function] static void double2_div(double2_t *a, double2_t *b, double2_t *c) ^~~~~~~~~~~ scipy/special/cython_special.c: In function '__pyx_f_5scipy_7special_7_cunity_cexpm1': scipy/special/cython_special.c:84539:31: warning: '__pyx_v_ezr' may be used uninitialized in this function [-Wmaybe-uninitialized] __pyx_v_y = ((__pyx_v_ezr + 1.0) * sin(__pyx_v_zi)); ~~~~~~~~~~~~~^~~~~~ scipy/special/cython_special.c: In function '__pyx_fuse_0__pyx_f_5scipy_7special_14cython_special_expm1': scipy/special/cython_special.c:84539:31: warning: '__pyx_v_ezr' may be used uninitialized in this function [-Wmaybe-uninitialized] __pyx_v_y = ((__pyx_v_ezr + 1.0) * sin(__pyx_v_zi)); ~~~~~~~~~~~~~^~~~~~ scipy/special/cython_special.c:84406:10: note: '__pyx_v_ezr' was declared here double __pyx_v_ezr; ^~~~~~~~~~~ scipy/special/cython_special.c: In function '__pyx_pw_5scipy_7special_14cython_special_705__pyx_fuse_0expm1': scipy/special/cython_special.c:84539:31: warning: '__pyx_v_ezr' may be used uninitialized in this function [-Wmaybe-uninitialized] __pyx_v_y = ((__pyx_v_ezr + 1.0) * sin(__pyx_v_zi)); ~~~~~~~~~~~~~^~~~~~ scipy/special/cython_special.c:84406:10: note: '__pyx_v_ezr' was declared here double __pyx_v_ezr; ^~~~~~~~~~~ /usr/bin/gfortran -Wall -g -Wl,-z,relro -Wl,-z,now -specs=/usr/lib/rpm/redhat/redhat-hardened-ld -shared build/temp.linux-ppc64le-2.7/scipy/special/cython_special.o build/temp.linux-ppc64le-2.7/scipy/special/sf_error.o build/temp.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/special/_logit.o build/temp.linux-ppc64le-2.7/scipy/special/amos_wrappers.o build/temp.linux-ppc64le-2.7/scipy/special/cdf_wrappers.o build/temp.linux-ppc64le-2.7/scipy/special/specfun_wrappers.o -L/usr/lib64 -L/usr/lib64/python2.7/site-packages/numpy/core/lib -L/usr/lib/gcc/ppc64le-redhat-linux/8 -L/usr/lib/gcc/ppc64le-redhat-linux/8 -L/usr/lib64 -Lbuild/temp.linux-ppc64le-2.7 -Wl,-rpath="/usr/lib64" -lopenblasp -lopenblas -lsc_amos -lsc_c_misc -lsc_cephes -lsc_mach -lsc_cdf -lsc_specfun -lnpymath -lm -lpython2.7 -lgfortran -o build/lib.linux-ppc64le-2.7/scipy/special/cython_special.so building 'scipy.special._comb' extension compiling C sources C compiler: gcc -pthread -fno-strict-aliasing -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -D_GNU_SOURCE -fPIC -fwrapv -DNDEBUG -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -D_GNU_SOURCE -fPIC -fwrapv -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -fPIC compile options: '-I/usr/lib64/python2.7/site-packages/numpy/core/include -I/usr/include/python2.7 -c' gcc: scipy/special/_comb.c gcc -pthread -shared -Wl,-z,relro -Wl,-z,now -specs=/usr/lib/rpm/redhat/redhat-hardened-ld -Wl,-z,relro -Wl,-z,now -specs=/usr/lib/rpm/redhat/redhat-hardened-ld -shared -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection build/temp.linux-ppc64le-2.7/scipy/special/_comb.o -L/usr/lib64 -Lbuild/temp.linux-ppc64le-2.7 -lpython2.7 -o build/lib.linux-ppc64le-2.7/scipy/special/_comb.so building 'scipy.special._test_round' extension compiling C sources C compiler: gcc -pthread -fno-strict-aliasing -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -D_GNU_SOURCE -fPIC -fwrapv -DNDEBUG -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -D_GNU_SOURCE -fPIC -fwrapv -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -fPIC compile options: '-I/usr/lib64/python2.7/site-packages/numpy/core/include -I/usr/lib64/python2.7/site-packages/numpy/core/include -I/usr/lib64/python2.7/site-packages/numpy/core/include -I/usr/include/python2.7 -c' gcc: scipy/special/_test_round.c In file included from scipy/special/_round.h:10, from scipy/special/_test_round.c:432: scipy/special/c_misc/double2.h:235:15: warning: 'double2_double' defined but not used [-Wunused-function] static double double2_double(double2_t *a) ^~~~~~~~~~~~~~ scipy/special/c_misc/double2.h:208:13: warning: 'double2_div' defined but not used [-Wunused-function] static void double2_div(double2_t *a, double2_t *b, double2_t *c) ^~~~~~~~~~~ gcc -pthread -shared -Wl,-z,relro -Wl,-z,now -specs=/usr/lib/rpm/redhat/redhat-hardened-ld -Wl,-z,relro -Wl,-z,now -specs=/usr/lib/rpm/redhat/redhat-hardened-ld -shared -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection build/temp.linux-ppc64le-2.7/scipy/special/_test_round.o -L/usr/lib64/python2.7/site-packages/numpy/core/lib -L/usr/lib64 -Lbuild/temp.linux-ppc64le-2.7 -lnpymath -lm -lpython2.7 -o build/lib.linux-ppc64le-2.7/scipy/special/_test_round.so building 'scipy.stats.statlib' extension compiling C sources C compiler: gcc -pthread -fno-strict-aliasing -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -D_GNU_SOURCE -fPIC -fwrapv -DNDEBUG -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -D_GNU_SOURCE -fPIC -fwrapv -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -fPIC creating build/temp.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/stats creating build/temp.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/stats compile options: '-Ibuild/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/stats -I/usr/lib64/python2.7/site-packages/numpy/core/include -I/usr/include/python2.7 -c' gcc: build/src.linux-ppc64le-2.7/scipy/stats/statlibmodule.c In file included from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/ndarraytypes.h:1816, from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/ndarrayobject.h:18, from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/arrayobject.h:4, from build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/stats/fortranobject.h:13, from build/src.linux-ppc64le-2.7/scipy/stats/statlibmodule.c:16: /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/npy_1_7_deprecated_api.h:15:2: warning: #warning "Using deprecated NumPy API, disable it by " "#defining NPY_NO_DEPRECATED_API NPY_1_7_API_VERSION" [-Wcpp] #warning "Using deprecated NumPy API, disable it by " \ ^~~~~~~ build/src.linux-ppc64le-2.7/scipy/stats/statlibmodule.c: In function 'f2py_rout_statlib_swilk': build/src.linux-ppc64le-2.7/scipy/stats/statlibmodule.c:243:39: warning: this 'else' clause does not guard... [-Wmisleading-indentation] if (init_capi == Py_None) init = 0; else ^~~~ build/src.linux-ppc64le-2.7/scipy/stats/statlibmodule.c:245:5: note: ...this statement, but the latter is misleadingly indented as if it were guarded by the 'else' f2py_success = 1; ^~~~~~~~~~~~ build/src.linux-ppc64le-2.7/scipy/stats/statlibmodule.c: In function 'f2py_rout_statlib_prho': build/src.linux-ppc64le-2.7/scipy/stats/statlibmodule.c:490:10: warning: variable 'prho_return_value' set but not used [-Wunused-but-set-variable] double prho_return_value=0; ^~~~~~~~~~~~~~~~~ At top level: build/src.linux-ppc64le-2.7/scipy/stats/statlibmodule.c:109:12: warning: 'f2py_size' defined but not used [-Wunused-function] static int f2py_size(PyArrayObject* var, ...) ^~~~~~~~~ gcc: build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/stats/fortranobject.c In file included from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/ndarraytypes.h:1816, from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/ndarrayobject.h:18, from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/arrayobject.h:4, from build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/stats/fortranobject.h:13, from build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/stats/fortranobject.c:2: /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/npy_1_7_deprecated_api.h:15:2: warning: #warning "Using deprecated NumPy API, disable it by " "#defining NPY_NO_DEPRECATED_API NPY_1_7_API_VERSION" [-Wcpp] #warning "Using deprecated NumPy API, disable it by " \ ^~~~~~~ /usr/bin/gfortran -Wall -g -Wl,-z,relro -Wl,-z,now -specs=/usr/lib/rpm/redhat/redhat-hardened-ld -shared build/temp.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/stats/statlibmodule.o build/temp.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/stats/fortranobject.o -L/usr/lib/gcc/ppc64le-redhat-linux/8 -L/usr/lib/gcc/ppc64le-redhat-linux/8 -L/usr/lib64 -Lbuild/temp.linux-ppc64le-2.7 -lstatlib -lpython2.7 -lgfortran -o build/lib.linux-ppc64le-2.7/scipy/stats/statlib.so building 'scipy.stats._stats' extension compiling C sources C compiler: gcc -pthread -fno-strict-aliasing -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -D_GNU_SOURCE -fPIC -fwrapv -DNDEBUG -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -D_GNU_SOURCE -fPIC -fwrapv -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -fPIC compile options: '-I/usr/lib64/python2.7/site-packages/numpy/core/include -I/usr/include/python2.7 -c' gcc: scipy/stats/_stats.c In file included from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/ndarraytypes.h:1816, from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/ndarrayobject.h:18, from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/arrayobject.h:4, from scipy/stats/_stats.c:437: /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/npy_1_7_deprecated_api.h:15:2: warning: #warning "Using deprecated NumPy API, disable it by " "#defining NPY_NO_DEPRECATED_API NPY_1_7_API_VERSION" [-Wcpp] #warning "Using deprecated NumPy API, disable it by " \ ^~~~~~~ scipy/stats/_stats.c: In function '__pyx_pf_5scipy_5stats_6_stats_4_toint64.isra.55': scipy/stats/_stats.c:5056:6: warning: '__pyx_v_i' may be used uninitialized in this function [-Wmaybe-uninitialized] if (__pyx_t_13) { ^ gcc -pthread -shared -Wl,-z,relro -Wl,-z,now -specs=/usr/lib/rpm/redhat/redhat-hardened-ld -Wl,-z,relro -Wl,-z,now -specs=/usr/lib/rpm/redhat/redhat-hardened-ld -shared -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection build/temp.linux-ppc64le-2.7/scipy/stats/_stats.o -L/usr/lib64 -Lbuild/temp.linux-ppc64le-2.7 -lpython2.7 -o build/lib.linux-ppc64le-2.7/scipy/stats/_stats.so building 'scipy.stats.mvn' extension compiling C sources C compiler: gcc -pthread -fno-strict-aliasing -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -D_GNU_SOURCE -fPIC -fwrapv -DNDEBUG -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -D_GNU_SOURCE -fPIC -fwrapv -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -fPIC compile options: '-Ibuild/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/stats -I/usr/lib64/python2.7/site-packages/numpy/core/include -I/usr/include/python2.7 -c' gcc: build/src.linux-ppc64le-2.7/scipy/stats/mvnmodule.c In file included from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/ndarraytypes.h:1816, from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/ndarrayobject.h:18, from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/arrayobject.h:4, from build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/stats/fortranobject.h:13, from build/src.linux-ppc64le-2.7/scipy/stats/mvnmodule.c:16: /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/npy_1_7_deprecated_api.h:15:2: warning: #warning "Using deprecated NumPy API, disable it by " "#defining NPY_NO_DEPRECATED_API NPY_1_7_API_VERSION" [-Wcpp] #warning "Using deprecated NumPy API, disable it by " \ ^~~~~~~ build/src.linux-ppc64le-2.7/scipy/stats/mvnmodule.c:102:12: warning: 'f2py_size' defined but not used [-Wunused-function] static int f2py_size(PyArrayObject* var, ...) ^~~~~~~~~ compiling Fortran sources Fortran f77 compiler: /usr/bin/gfortran -Wall -g -ffixed-form -fno-second-underscore -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -fPIC -cpp -O3 -funroll-loops Fortran f90 compiler: /usr/bin/gfortran -Wall -g -fno-second-underscore -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -fPIC -cpp -O3 -funroll-loops Fortran fix compiler: /usr/bin/gfortran -Wall -g -ffixed-form -fno-second-underscore -Wall -g -fno-second-underscore -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -fPIC -cpp -O3 -funroll-loops compile options: '-Ibuild/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/stats -I/usr/lib64/python2.7/site-packages/numpy/core/include -I/usr/include/python2.7 -c' gfortran:f77: scipy/stats/mvndst.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran scipy/stats/mvndst.f:142:18: INFORM = MVNDNT(N, CORREL, LOWER, UPPER, INFIN, INFIS, D, E) 1 Warning: Possible change of value in conversion from REAL(8) to INTEGER(4) at (1) [-Wconversion] scipy/stats/mvndst.f:727:14: JP = J + MVNUNI()*( NK + 1 - J ) 1 Warning: Possible change of value in conversion from REAL(8) to INTEGER(4) at (1) [-Wconversion] scipy/stats/mvndst.f:963:0: END Warning: '__result_bvnmvn' may be used uninitialized in this function [-Wmaybe-uninitialized] scipy/stats/mvndst.f:921:0: DOUBLE PRECISION FUNCTION BVNMVN( LOWER, UPPER, INFIN, CORREL ) note: '__result_bvnmvn' was declared here scipy/stats/mvndst.f:368:0: IF ( INFI(I) .EQ. 2 ) Y(I) = ( AMIN + BMIN )/2 Warning: 'bmin' may be used uninitialized in this function [-Wmaybe-uninitialized] scipy/stats/mvndst.f:362:0: IF ( INFI(I) .NE. 0 ) YL = -EXP( -AMIN**2/2 )/SQTWPI Warning: 'amin' may be used uninitialized in this function [-Wmaybe-uninitialized] gfortran:f77: build/src.linux-ppc64le-2.7/scipy/stats/mvn-f2pywrappers.f f951: Warning: '-Werror=' argument '-Werror=format-security' is not valid for Fortran /usr/bin/gfortran -Wall -g -Wl,-z,relro -Wl,-z,now -specs=/usr/lib/rpm/redhat/redhat-hardened-ld -shared build/temp.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/stats/mvnmodule.o build/temp.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/stats/fortranobject.o build/temp.linux-ppc64le-2.7/scipy/stats/mvndst.o build/temp.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/stats/mvn-f2pywrappers.o -L/usr/lib/gcc/ppc64le-redhat-linux/8 -L/usr/lib/gcc/ppc64le-redhat-linux/8 -L/usr/lib64 -Lbuild/temp.linux-ppc64le-2.7 -lpython2.7 -lgfortran -o build/lib.linux-ppc64le-2.7/scipy/stats/mvn.so building 'scipy.ndimage._nd_image' extension compiling C sources C compiler: gcc -pthread -fno-strict-aliasing -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -D_GNU_SOURCE -fPIC -fwrapv -DNDEBUG -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -D_GNU_SOURCE -fPIC -fwrapv -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -fPIC creating build/temp.linux-ppc64le-2.7/scipy/ndimage creating build/temp.linux-ppc64le-2.7/scipy/ndimage/src compile options: '-DNPY_NO_DEPRECATED_API=NPY_1_9_API_VERSION -DHAVE_CBLAS -Iscipy/ndimage/src -I/usr/lib64/python2.7/site-packages/numpy/core/include -Iscipy/_lib/src -I/usr/lib64/python2.7/site-packages/numpy/core/include -I/usr/include/python2.7 -c' gcc: scipy/ndimage/src/ni_measure.c gcc: scipy/ndimage/src/ni_support.c gcc: scipy/ndimage/src/ni_interpolation.c gcc: scipy/ndimage/src/ni_fourier.c gcc: scipy/ndimage/src/nd_image.c In file included from scipy/ndimage/src/nd_image.c:45: scipy/_lib/src/ccallback.h:87:21: warning: 'ccallback_obtain' defined but not used [-Wunused-function] static ccallback_t *ccallback_obtain(void) ^~~~~~~~~~~~~~~~ gcc: scipy/ndimage/src/ni_morphology.c gcc: scipy/ndimage/src/ni_filters.c gcc -pthread -shared -Wl,-z,relro -Wl,-z,now -specs=/usr/lib/rpm/redhat/redhat-hardened-ld -Wl,-z,relro -Wl,-z,now -specs=/usr/lib/rpm/redhat/redhat-hardened-ld -shared -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection build/temp.linux-ppc64le-2.7/scipy/ndimage/src/nd_image.o build/temp.linux-ppc64le-2.7/scipy/ndimage/src/ni_filters.o build/temp.linux-ppc64le-2.7/scipy/ndimage/src/ni_fourier.o build/temp.linux-ppc64le-2.7/scipy/ndimage/src/ni_interpolation.o build/temp.linux-ppc64le-2.7/scipy/ndimage/src/ni_measure.o build/temp.linux-ppc64le-2.7/scipy/ndimage/src/ni_morphology.o build/temp.linux-ppc64le-2.7/scipy/ndimage/src/ni_support.o -L/usr/lib64 -Lbuild/temp.linux-ppc64le-2.7 -lpython2.7 -o build/lib.linux-ppc64le-2.7/scipy/ndimage/_nd_image.so building 'scipy.ndimage._ni_label' extension compiling C sources C compiler: gcc -pthread -fno-strict-aliasing -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -D_GNU_SOURCE -fPIC -fwrapv -DNDEBUG -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -D_GNU_SOURCE -fPIC -fwrapv -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -fPIC compile options: '-Iscipy/ndimage/src -I/usr/lib64/python2.7/site-packages/numpy/core/include -I/usr/lib64/python2.7/site-packages/numpy/core/include -I/usr/include/python2.7 -c' gcc: scipy/ndimage/src/_ni_label.c In file included from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/ndarraytypes.h:1816, from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/ndarrayobject.h:18, from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/arrayobject.h:4, from scipy/ndimage/src/_ni_label.c:435: /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/npy_1_7_deprecated_api.h:15:2: warning: #warning "Using deprecated NumPy API, disable it by " "#defining NPY_NO_DEPRECATED_API NPY_1_7_API_VERSION" [-Wcpp] #warning "Using deprecated NumPy API, disable it by " \ ^~~~~~~ gcc -pthread -shared -Wl,-z,relro -Wl,-z,now -specs=/usr/lib/rpm/redhat/redhat-hardened-ld -Wl,-z,relro -Wl,-z,now -specs=/usr/lib/rpm/redhat/redhat-hardened-ld -shared -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection build/temp.linux-ppc64le-2.7/scipy/ndimage/src/_ni_label.o -L/usr/lib64 -Lbuild/temp.linux-ppc64le-2.7 -lpython2.7 -o build/lib.linux-ppc64le-2.7/scipy/ndimage/_ni_label.so building 'scipy.ndimage._ctest' extension compiling C sources C compiler: gcc -pthread -fno-strict-aliasing -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -D_GNU_SOURCE -fPIC -fwrapv -DNDEBUG -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -D_GNU_SOURCE -fPIC -fwrapv -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -fPIC compile options: '-DNPY_NO_DEPRECATED_API=NPY_1_9_API_VERSION -DHAVE_CBLAS -I/usr/lib64/python2.7/site-packages/numpy/core/include -I/usr/lib64/python2.7/site-packages/numpy/core/include -I/usr/include/python2.7 -c' gcc: scipy/ndimage/src/_ctest.c In file included from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/ndarrayobject.h:27, from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/npy_3kcompat.h:23, from scipy/ndimage/src/_ctest.c:3: /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/__multiarray_api.h:1463:1: warning: '_import_array' defined but not used [-Wunused-function] _import_array(void) ^~~~~~~~~~~~~ gcc -pthread -shared -Wl,-z,relro -Wl,-z,now -specs=/usr/lib/rpm/redhat/redhat-hardened-ld -Wl,-z,relro -Wl,-z,now -specs=/usr/lib/rpm/redhat/redhat-hardened-ld -shared -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection build/temp.linux-ppc64le-2.7/scipy/ndimage/src/_ctest.o -L/usr/lib64 -Lbuild/temp.linux-ppc64le-2.7 -lpython2.7 -o build/lib.linux-ppc64le-2.7/scipy/ndimage/_ctest.so building 'scipy.ndimage._ctest_oldapi' extension compiling C sources C compiler: gcc -pthread -fno-strict-aliasing -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -D_GNU_SOURCE -fPIC -fwrapv -DNDEBUG -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -D_GNU_SOURCE -fPIC -fwrapv -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -fPIC compile options: '-DOLDAPI=1 -DNPY_NO_DEPRECATED_API=NPY_1_9_API_VERSION -DHAVE_CBLAS -I/usr/lib64/python2.7/site-packages/numpy/core/include -I/usr/lib64/python2.7/site-packages/numpy/core/include -I/usr/include/python2.7 -c' gcc: scipy/ndimage/src/_ctest.c In file included from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/ndarrayobject.h:27, from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/npy_3kcompat.h:23, from scipy/ndimage/src/_ctest.c:3: /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/__multiarray_api.h:1463:1: warning: '_import_array' defined but not used [-Wunused-function] _import_array(void) ^~~~~~~~~~~~~ gcc -pthread -shared -Wl,-z,relro -Wl,-z,now -specs=/usr/lib/rpm/redhat/redhat-hardened-ld -Wl,-z,relro -Wl,-z,now -specs=/usr/lib/rpm/redhat/redhat-hardened-ld -shared -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection build/temp.linux-ppc64le-2.7/scipy/ndimage/src/_ctest.o -L/usr/lib64 -Lbuild/temp.linux-ppc64le-2.7 -lpython2.7 -o build/lib.linux-ppc64le-2.7/scipy/ndimage/_ctest_oldapi.so building 'scipy.ndimage._cytest' extension compiling C sources C compiler: gcc -pthread -fno-strict-aliasing -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -D_GNU_SOURCE -fPIC -fwrapv -DNDEBUG -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -D_GNU_SOURCE -fPIC -fwrapv -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -fPIC compile options: '-I/usr/lib64/python2.7/site-packages/numpy/core/include -I/usr/include/python2.7 -c' gcc: scipy/ndimage/src/_cytest.c In file included from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/ndarraytypes.h:1816, from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/ndarrayobject.h:18, from /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/arrayobject.h:4, from scipy/ndimage/src/_cytest.c:435: /usr/lib64/python2.7/site-packages/numpy/core/include/numpy/npy_1_7_deprecated_api.h:15:2: warning: #warning "Using deprecated NumPy API, disable it by " "#defining NPY_NO_DEPRECATED_API NPY_1_7_API_VERSION" [-Wcpp] #warning "Using deprecated NumPy API, disable it by " \ ^~~~~~~ gcc -pthread -shared -Wl,-z,relro -Wl,-z,now -specs=/usr/lib/rpm/redhat/redhat-hardened-ld -Wl,-z,relro -Wl,-z,now -specs=/usr/lib/rpm/redhat/redhat-hardened-ld -shared -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection build/temp.linux-ppc64le-2.7/scipy/ndimage/src/_cytest.o -L/usr/lib64 -Lbuild/temp.linux-ppc64le-2.7 -lpython2.7 -o build/lib.linux-ppc64le-2.7/scipy/ndimage/_cytest.so building 'scipy._lib._ccallback_c' extension compiling C sources C compiler: gcc -pthread -fno-strict-aliasing -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -D_GNU_SOURCE -fPIC -fwrapv -DNDEBUG -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -D_GNU_SOURCE -fPIC -fwrapv -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -fPIC creating build/temp.linux-ppc64le-2.7/scipy/_lib compile options: '-I/builddir/build/BUILD/scipy-1.0.0/scipy/_lib/src -I/usr/lib64/python2.7/site-packages/numpy/core/include -I/usr/include/python2.7 -c' gcc: scipy/_lib/_ccallback_c.c scipy/_lib/_ccallback_c.c: In function '__pyx_f_5scipy_4_lib_12_ccallback_c_raw_capsule_destructor': scipy/_lib/_ccallback_c.c:1165:13: warning: assignment discards 'const' qualifier from pointer target type [-Wdiscarded-qualifiers] __pyx_t_1 = PyCapsule_GetName(__pyx_v_capsule); if (unlikely(__pyx_t_1 == NULL && PyErr_Occurred())) __PYX_ERR(0, 21, __pyx_L1_error) ^ scipy/_lib/_ccallback_c.c: In function '__pyx_pf_5scipy_4_lib_12_ccallback_c_get_raw_capsule': scipy/_lib/_ccallback_c.c:1395:15: warning: assignment discards 'const' qualifier from pointer target type [-Wdiscarded-qualifiers] __pyx_t_5 = PyCapsule_GetName(__pyx_v_context_obj); if (unlikely(__pyx_t_5 == NULL && PyErr_Occurred())) __PYX_ERR(0, 58, __pyx_L1_error) ^ scipy/_lib/_ccallback_c.c:1487:15: warning: assignment discards 'const' qualifier from pointer target type [-Wdiscarded-qualifiers] __pyx_t_5 = PyCapsule_GetName(__pyx_v_func_obj); if (unlikely(__pyx_t_5 == NULL && PyErr_Occurred())) __PYX_ERR(0, 66, __pyx_L1_error) ^ scipy/_lib/_ccallback_c.c: In function '__pyx_pf_5scipy_4_lib_12_ccallback_c_2get_capsule_signature': scipy/_lib/_ccallback_c.c:1743:13: warning: assignment discards 'const' qualifier from pointer target type [-Wdiscarded-qualifiers] __pyx_t_1 = PyCapsule_GetName(__pyx_v_capsule_obj); if (unlikely(__pyx_t_1 == NULL && PyErr_Occurred())) __PYX_ERR(0, 90, __pyx_L1_error) ^ In file included from scipy/_lib/_ccallback_c.c:436: At top level: /builddir/build/BUILD/scipy-1.0.0/scipy/_lib/src/ccallback.h:87:21: warning: 'ccallback_obtain' defined but not used [-Wunused-function] static ccallback_t *ccallback_obtain(void) ^~~~~~~~~~~~~~~~ gcc -pthread -shared -Wl,-z,relro -Wl,-z,now -specs=/usr/lib/rpm/redhat/redhat-hardened-ld -Wl,-z,relro -Wl,-z,now -specs=/usr/lib/rpm/redhat/redhat-hardened-ld -shared -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection build/temp.linux-ppc64le-2.7/scipy/_lib/_ccallback_c.o -L/usr/lib64 -Lbuild/temp.linux-ppc64le-2.7 -lpython2.7 -o build/lib.linux-ppc64le-2.7/scipy/_lib/_ccallback_c.so building 'scipy._lib._test_ccallback' extension compiling C sources C compiler: gcc -pthread -fno-strict-aliasing -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -D_GNU_SOURCE -fPIC -fwrapv -DNDEBUG -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -D_GNU_SOURCE -fPIC -fwrapv -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -fPIC creating build/temp.linux-ppc64le-2.7/scipy/_lib/src compile options: '-I/builddir/build/BUILD/scipy-1.0.0/scipy/_lib/src -I/usr/lib64/python2.7/site-packages/numpy/core/include -I/usr/include/python2.7 -c' gcc: scipy/_lib/src/_test_ccallback.c In file included from /usr/include/python2.7/pyconfig.h:6, from /usr/include/python2.7/Python.h:8, from scipy/_lib/src/_test_ccallback.c:38: /usr/include/python2.7/pyconfig-64.h:1232: warning: "_POSIX_C_SOURCE" redefined #define _POSIX_C_SOURCE 200112L In file included from /usr/include/setjmp.h:25, from scipy/_lib/src/_test_ccallback.c:37: /usr/include/features.h:265: note: this is the location of the previous definition # define _POSIX_C_SOURCE 200809L In file included from /usr/include/python2.7/pyconfig.h:6, from /usr/include/python2.7/Python.h:8, from scipy/_lib/src/_test_ccallback.c:38: /usr/include/python2.7/pyconfig-64.h:1254: warning: "_XOPEN_SOURCE" redefined #define _XOPEN_SOURCE 600 In file included from /usr/include/setjmp.h:25, from scipy/_lib/src/_test_ccallback.c:37: /usr/include/features.h:202: note: this is the location of the previous definition # define _XOPEN_SOURCE 700 gcc -pthread -shared -Wl,-z,relro -Wl,-z,now -specs=/usr/lib/rpm/redhat/redhat-hardened-ld -Wl,-z,relro -Wl,-z,now -specs=/usr/lib/rpm/redhat/redhat-hardened-ld -shared -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection build/temp.linux-ppc64le-2.7/scipy/_lib/src/_test_ccallback.o -L/usr/lib64 -Lbuild/temp.linux-ppc64le-2.7 -lpython2.7 -o build/lib.linux-ppc64le-2.7/scipy/_lib/_test_ccallback.so building 'scipy._lib._fpumode' extension compiling C sources C compiler: gcc -pthread -fno-strict-aliasing -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -D_GNU_SOURCE -fPIC -fwrapv -DNDEBUG -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -D_GNU_SOURCE -fPIC -fwrapv -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -fPIC compile options: '-I/usr/lib64/python2.7/site-packages/numpy/core/include -I/usr/include/python2.7 -c' gcc: scipy/_lib/_fpumode.c gcc -pthread -shared -Wl,-z,relro -Wl,-z,now -specs=/usr/lib/rpm/redhat/redhat-hardened-ld -Wl,-z,relro -Wl,-z,now -specs=/usr/lib/rpm/redhat/redhat-hardened-ld -shared -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection build/temp.linux-ppc64le-2.7/scipy/_lib/_fpumode.o -L/usr/lib64 -Lbuild/temp.linux-ppc64le-2.7 -lpython2.7 -o build/lib.linux-ppc64le-2.7/scipy/_lib/_fpumode.so building 'scipy._lib.messagestream' extension compiling C sources C compiler: gcc -pthread -fno-strict-aliasing -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -D_GNU_SOURCE -fPIC -fwrapv -DNDEBUG -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -D_GNU_SOURCE -fPIC -fwrapv -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -fPIC compile options: '-I/builddir/build/BUILD/scipy-1.0.0/scipy/_lib/src -I/usr/lib64/python2.7/site-packages/numpy/core/include -I/usr/include/python2.7 -c' gcc: scipy/_lib/messagestream.c gcc -pthread -shared -Wl,-z,relro -Wl,-z,now -specs=/usr/lib/rpm/redhat/redhat-hardened-ld -Wl,-z,relro -Wl,-z,now -specs=/usr/lib/rpm/redhat/redhat-hardened-ld -shared -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection build/temp.linux-ppc64le-2.7/scipy/_lib/messagestream.o -L/usr/lib64 -Lbuild/temp.linux-ppc64le-2.7 -lpython2.7 -o build/lib.linux-ppc64le-2.7/scipy/_lib/messagestream.so + exit 0 Executing(%install): /bin/sh -e /var/tmp/rpm-tmp.Bve5sv + umask 022 + cd /builddir/build/BUILD + '[' /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le '!=' / ']' + rm -rf /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le ++ dirname /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le + mkdir -p /builddir/build/BUILDROOT + mkdir /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le + cd scipy-1.0.0 + env 'CFLAGS=-O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection' 'FFLAGS=-O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -fPIC -cpp' 'LDFLAGS=-Wl,-z,relro -Wl,-z,now -specs=/usr/lib/rpm/redhat/redhat-hardened-ld -shared' OPENBLAS=/usr/lib64 FFTW=/usr/lib64 BLAS=/usr/lib64 LAPACK=/usr/lib64 /usr/bin/python2 setup.py install --root=/builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le Note: if you need reliable uninstall behavior, then install with pip instead of using `setup.py install`: - `pip install .` (from a git repo or downloaded source release) - `pip install scipy` (last SciPy release on PyPI) lapack_opt_info: lapack_mkl_info: customize UnixCCompiler libraries mkl_rt not found in ['/usr/local/lib64', '/usr/local/lib', '/usr/lib64', '/usr/lib', '/usr/lib/'] NOT AVAILABLE openblas_lapack_info: customize UnixCCompiler customize UnixCCompiler customize UnixCCompiler C compiler: gcc -pthread -fno-strict-aliasing -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -D_GNU_SOURCE -fPIC -fwrapv -DNDEBUG -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -D_GNU_SOURCE -fPIC -fwrapv -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -fPIC creating /tmp/tmpWjLGC5/tmp creating /tmp/tmpWjLGC5/tmp/tmpWjLGC5 compile options: '-c' gcc: /tmp/tmpWjLGC5/source.c /tmp/tmpWjLGC5/source.c: In function 'main': /tmp/tmpWjLGC5/source.c:4:13: warning: implicit declaration of function 'zungqr_'; did you mean 'zungqr'? [-Wimplicit-function-declaration] zungqr_(); ^~~~~~~ zungqr gcc -pthread /tmp/tmpWjLGC5/tmp/tmpWjLGC5/source.o -L/usr/lib64 -lopenblasp -o /tmp/tmpWjLGC5/a.out customize UnixCCompiler customize UnixCCompiler FOUND: libraries = ['openblasp', 'openblas'] library_dirs = ['/usr/lib64'] language = c define_macros = [('HAVE_CBLAS', None)] runtime_library_dirs = ['/usr/lib64'] FOUND: libraries = ['openblasp', 'openblas'] library_dirs = ['/usr/lib64'] language = c define_macros = [('HAVE_CBLAS', None)] runtime_library_dirs = ['/usr/lib64'] Running from scipy source directory. /usr/lib64/python2.7/site-packages/numpy/distutils/system_info.py:716: UserWarning: Specified path /usr/lib64/python2.7/site-packages/numpy/__init__.pyc/include/python2.7 is invalid. return self.get_paths(self.section, key) /usr/lib64/python2.7/site-packages/numpy/distutils/system_info.py:716: UserWarning: Specified path /usr/local/include/python2.7 is invalid. return self.get_paths(self.section, key) /usr/lib64/python2.7/site-packages/numpy/distutils/system_info.py:716: UserWarning: Specified path /usr/include/suitesparse/python2.7 is invalid. return self.get_paths(self.section, key) Splitting linalg.interpolative Fortran source files blas_opt_info: blas_mkl_info: customize UnixCCompiler libraries mkl_rt not found in ['/usr/local/lib64', '/usr/local/lib', '/usr/lib64', '/usr/lib', '/usr/lib/'] NOT AVAILABLE blis_info: customize UnixCCompiler libraries blis not found in ['/usr/local/lib64', '/usr/local/lib', '/usr/lib64', '/usr/lib', '/usr/lib/'] NOT AVAILABLE openblas_info: customize UnixCCompiler customize UnixCCompiler customize UnixCCompiler customize UnixCCompiler FOUND: libraries = ['openblasp', 'openblas'] library_dirs = ['/usr/lib64'] language = c define_macros = [('HAVE_CBLAS', None)] runtime_library_dirs = ['/usr/lib64'] FOUND: libraries = ['openblasp', 'openblas'] library_dirs = ['/usr/lib64'] language = c define_macros = [('HAVE_CBLAS', None)] runtime_library_dirs = ['/usr/lib64'] running install running build running config_cc unifing config_cc, config, build_clib, build_ext, build commands --compiler options running config_fc unifing config_fc, config, build_clib, build_ext, build commands --fcompiler options running build_src build_src building py_modules sources building library "dfftpack" sources building library "fftpack" sources building library "mach" sources building library "quadpack" sources building library "lsoda" sources building library "vode" sources building library "dop" sources building library "fitpack" sources building library "fwrappers" sources building library "odrpack" sources building library "minpack" sources building library "rootfind" sources building library "superlu_src" sources building library "arpack_scipy" sources building library "sc_c_misc" sources building library "sc_cephes" sources building library "sc_mach" sources building library "sc_amos" sources building library "sc_cdf" sources building library "sc_specfun" sources building library "statlib" sources building extension "scipy.cluster._vq" sources building extension "scipy.cluster._hierarchy" sources building extension "scipy.cluster._optimal_leaf_ordering" sources building extension "scipy.fftpack._fftpack" sources f2py options: [] adding 'build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/fftpack/fortranobject.c' to sources. adding 'build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/fftpack' to include_dirs. building extension "scipy.fftpack.convolve" sources f2py options: [] adding 'build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/fftpack/fortranobject.c' to sources. adding 'build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/fftpack' to include_dirs. building extension "scipy.integrate._quadpack" sources building extension "scipy.integrate._odepack" sources building extension "scipy.integrate.vode" sources f2py options: [] adding 'build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/integrate/fortranobject.c' to sources. adding 'build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/integrate' to include_dirs. building extension "scipy.integrate.lsoda" sources f2py options: [] adding 'build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/integrate/fortranobject.c' to sources. adding 'build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/integrate' to include_dirs. building extension "scipy.integrate._dop" sources f2py options: [] adding 'build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/integrate/fortranobject.c' to sources. adding 'build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/integrate' to include_dirs. building extension "scipy.integrate._test_multivariate" sources building extension "scipy.integrate._test_odeint_banded" sources f2py options: [] adding 'build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/integrate/fortranobject.c' to sources. adding 'build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/integrate' to include_dirs. adding 'build/src.linux-ppc64le-2.7/scipy/integrate/_test_odeint_banded-f2pywrappers.f' to sources. building extension "scipy.interpolate.interpnd" sources building extension "scipy.interpolate._ppoly" sources building extension "scipy.interpolate._bspl" sources building extension "scipy.interpolate._fitpack" sources building extension "scipy.interpolate.dfitpack" sources f2py options: [] adding 'build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/interpolate/src/fortranobject.c' to sources. adding 'build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/interpolate/src' to include_dirs. adding 'build/src.linux-ppc64le-2.7/scipy/interpolate/src/dfitpack-f2pywrappers.f' to sources. building extension "scipy.interpolate._interpolate" sources building extension "scipy.io._test_fortran" sources f2py options: [] adding 'build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/io/fortranobject.c' to sources. adding 'build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/io' to include_dirs. building extension "scipy.io.matlab.streams" sources building extension "scipy.io.matlab.mio_utils" sources building extension "scipy.io.matlab.mio5_utils" sources building extension "scipy.linalg._fblas" sources f2py options: [] adding 'build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/linalg/fortranobject.c' to sources. adding 'build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/linalg' to include_dirs. adding 'build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/linalg/_fblas-f2pywrappers.f' to sources. building extension "scipy.linalg._flapack" sources f2py options: [] adding 'build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/linalg/fortranobject.c' to sources. adding 'build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/linalg' to include_dirs. adding 'build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/linalg/_flapack-f2pywrappers.f' to sources. building extension "scipy.linalg._flinalg" sources f2py options: [] adding 'build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/linalg/fortranobject.c' to sources. adding 'build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/linalg' to include_dirs. building extension "scipy.linalg._interpolative" sources f2py options: [] adding 'build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/linalg/fortranobject.c' to sources. adding 'build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/linalg' to include_dirs. building extension "scipy.linalg._solve_toeplitz" sources building extension "scipy.linalg.cython_blas" sources building extension "scipy.linalg.cython_lapack" sources building extension "scipy.linalg._decomp_update" sources building extension "scipy.odr.__odrpack" sources building extension "scipy.optimize._minpack" sources building extension "scipy.optimize._zeros" sources building extension "scipy.optimize._lbfgsb" sources f2py options: [] adding 'build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/optimize/lbfgsb/fortranobject.c' to sources. adding 'build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/optimize/lbfgsb' to include_dirs. building extension "scipy.optimize.moduleTNC" sources building extension "scipy.optimize._cobyla" sources f2py options: [] adding 'build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/optimize/cobyla/fortranobject.c' to sources. adding 'build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/optimize/cobyla' to include_dirs. building extension "scipy.optimize.minpack2" sources f2py options: [] adding 'build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/optimize/minpack2/fortranobject.c' to sources. adding 'build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/optimize/minpack2' to include_dirs. building extension "scipy.optimize._slsqp" sources f2py options: [] adding 'build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/optimize/slsqp/fortranobject.c' to sources. adding 'build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/optimize/slsqp' to include_dirs. building extension "scipy.optimize._nnls" sources f2py options: [] adding 'build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/optimize/nnls/fortranobject.c' to sources. adding 'build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/optimize/nnls' to include_dirs. building extension "scipy.optimize._group_columns" sources building extension "scipy.optimize._lsq.givens_elimination" sources building extension "scipy.optimize._trlib._trlib" sources building extension "scipy.signal.sigtools" sources building extension "scipy.signal._spectral" sources building extension "scipy.signal._max_len_seq_inner" sources building extension "scipy.signal._upfirdn_apply" sources building extension "scipy.signal.spline" sources building extension "scipy.sparse.linalg.isolve._iterative" sources f2py options: [] adding 'build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/sparse/linalg/isolve/iterative/fortranobject.c' to sources. adding 'build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/sparse/linalg/isolve/iterative' to include_dirs. building extension "scipy.sparse.linalg.dsolve._superlu" sources building extension "scipy.sparse.linalg.eigen.arpack._arpack" sources f2py options: [] adding 'build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/sparse/linalg/eigen/arpack/fortranobject.c' to sources. adding 'build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/sparse/linalg/eigen/arpack' to include_dirs. adding 'build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/sparse/linalg/eigen/arpack/_arpack-f2pywrappers.f' to sources. building extension "scipy.sparse.csgraph._shortest_path" sources building extension "scipy.sparse.csgraph._traversal" sources building extension "scipy.sparse.csgraph._min_spanning_tree" sources building extension "scipy.sparse.csgraph._reordering" sources building extension "scipy.sparse.csgraph._tools" sources building extension "scipy.sparse._csparsetools" sources building extension "scipy.sparse._sparsetools" sources [generate_sparsetools] 'scipy/sparse/sparsetools/bsr_impl.h' already up-to-date [generate_sparsetools] 'scipy/sparse/sparsetools/csr_impl.h' already up-to-date [generate_sparsetools] 'scipy/sparse/sparsetools/csc_impl.h' already up-to-date [generate_sparsetools] 'scipy/sparse/sparsetools/other_impl.h' already up-to-date [generate_sparsetools] 'scipy/sparse/sparsetools/sparsetools_impl.h' already up-to-date building extension "scipy.spatial.qhull" sources building extension "scipy.spatial.ckdtree" sources building extension "scipy.spatial._distance_wrap" sources building extension "scipy.spatial._voronoi" sources building extension "scipy.spatial._hausdorff" sources building extension "scipy.special.specfun" sources f2py options: ['--no-wrap-functions'] adding 'build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/special/fortranobject.c' to sources. adding 'build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/special' to include_dirs. building extension "scipy.special._ufuncs" sources building extension "scipy.special._ufuncs_cxx" sources building extension "scipy.special._ellip_harm_2" sources building extension "scipy.special.cython_special" sources building extension "scipy.special._comb" sources building extension "scipy.special._test_round" sources building extension "scipy.stats.statlib" sources f2py options: ['--no-wrap-functions'] adding 'build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/stats/fortranobject.c' to sources. adding 'build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/stats' to include_dirs. building extension "scipy.stats._stats" sources building extension "scipy.stats.mvn" sources f2py options: [] adding 'build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/stats/fortranobject.c' to sources. adding 'build/src.linux-ppc64le-2.7/build/src.linux-ppc64le-2.7/scipy/stats' to include_dirs. adding 'build/src.linux-ppc64le-2.7/scipy/stats/mvn-f2pywrappers.f' to sources. building extension "scipy.ndimage._nd_image" sources building extension "scipy.ndimage._ni_label" sources building extension "scipy.ndimage._ctest" sources building extension "scipy.ndimage._ctest_oldapi" sources building extension "scipy.ndimage._cytest" sources building extension "scipy._lib._ccallback_c" sources building extension "scipy._lib._test_ccallback" sources building extension "scipy._lib._fpumode" sources building extension "scipy._lib.messagestream" sources get_default_fcompiler: matching types: '['gnu95', 'intel', 'lahey', 'pg', 'absoft', 'nag', 'vast', 'compaq', 'intele', 'intelem', 'gnu', 'g95', 'pathf95', 'nagfor']' customize Gnu95FCompiler Found executable /usr/bin/gfortran customize Gnu95FCompiler customize Gnu95FCompiler using config C compiler: gcc -pthread -fno-strict-aliasing -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -D_GNU_SOURCE -fPIC -fwrapv -DNDEBUG -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -D_GNU_SOURCE -fPIC -fwrapv -O2 -g -pipe -Wall -Werror=format-security -Wp,-D_FORTIFY_SOURCE=2 -Wp,-D_GLIBCXX_ASSERTIONS -fexceptions -fstack-protector-strong -grecord-gcc-switches -specs=/usr/lib/rpm/redhat/redhat-hardened-cc1 -specs=/usr/lib/rpm/redhat/redhat-annobin-cc1 -m64 -mcpu=power8 -mtune=power8 -funwind-tables -fstack-clash-protection -fPIC compile options: '-I/usr/include/python2.7 -c' gcc: _configtest.c gcc -pthread _configtest.o -o _configtest success! removing: _configtest.c _configtest.o _configtest building data_files sources build_src: building npy-pkg config files running build_py copying scipy/version.py -> build/lib.linux-ppc64le-2.7/scipy copying build/src.linux-ppc64le-2.7/scipy/__config__.py -> build/lib.linux-ppc64le-2.7/scipy running build_clib customize UnixCCompiler customize UnixCCompiler using build_clib get_default_fcompiler: matching types: '['gnu95', 'intel', 'lahey', 'pg', 'absoft', 'nag', 'vast', 'compaq', 'intele', 'intelem', 'gnu', 'g95', 'pathf95', 'nagfor']' customize Gnu95FCompiler customize Gnu95FCompiler customize Gnu95FCompiler using build_clib running build_ext customize UnixCCompiler customize UnixCCompiler using build_ext resetting extension 'scipy.integrate._quadpack' language from 'c' to 'f77'. resetting extension 'scipy.integrate._odepack' language from 'c' to 'f77'. resetting extension 'scipy.integrate.vode' language from 'c' to 'f77'. resetting extension 'scipy.integrate.lsoda' language from 'c' to 'f77'. resetting extension 'scipy.integrate._test_odeint_banded' language from 'c' to 'f77'. resetting extension 'scipy.linalg._fblas' language from 'c' to 'f77'. resetting extension 'scipy.linalg._flapack' language from 'c' to 'f77'. resetting extension 'scipy.linalg._flinalg' language from 'c' to 'f77'. resetting extension 'scipy.linalg._interpolative' language from 'c' to 'f77'. resetting extension 'scipy.linalg.cython_blas' language from 'c' to 'f77'. resetting extension 'scipy.linalg.cython_lapack' language from 'c' to 'f77'. resetting extension 'scipy.odr.__odrpack' language from 'c' to 'f77'. resetting extension 'scipy.optimize._lbfgsb' language from 'c' to 'f77'. resetting extension 'scipy.sparse.linalg.isolve._iterative' language from 'c' to 'f77'. extending extension 'scipy.sparse.linalg.dsolve._superlu' defined_macros with [('USE_VENDOR_BLAS', 1)] resetting extension 'scipy.sparse.linalg.eigen.arpack._arpack' language from 'c' to 'f77'. resetting extension 'scipy.special._ufuncs' language from 'c' to 'f77'. resetting extension 'scipy.special.cython_special' language from 'c' to 'f77'. customize UnixCCompiler customize UnixCCompiler using build_ext get_default_fcompiler: matching types: '['gnu95', 'intel', 'lahey', 'pg', 'absoft', 'nag', 'vast', 'compaq', 'intele', 'intelem', 'gnu', 'g95', 'pathf95', 'nagfor']' customize Gnu95FCompiler customize Gnu95FCompiler customize Gnu95FCompiler using build_ext running install_lib creating /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr creating /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64 creating /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7 creating /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages creating /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy creating /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/integrate copying build/lib.linux-ppc64le-2.7/scipy/integrate/quadpack.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/integrate copying build/lib.linux-ppc64le-2.7/scipy/integrate/_odepack.so -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/integrate copying build/lib.linux-ppc64le-2.7/scipy/integrate/quadrature.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/integrate copying build/lib.linux-ppc64le-2.7/scipy/integrate/__init__.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/integrate copying build/lib.linux-ppc64le-2.7/scipy/integrate/_test_multivariate.so -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/integrate copying build/lib.linux-ppc64le-2.7/scipy/integrate/lsoda.so -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/integrate creating /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/integrate/_ivp copying build/lib.linux-ppc64le-2.7/scipy/integrate/_ivp/bdf.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/integrate/_ivp copying build/lib.linux-ppc64le-2.7/scipy/integrate/_ivp/rk.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/integrate/_ivp copying build/lib.linux-ppc64le-2.7/scipy/integrate/_ivp/__init__.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/integrate/_ivp copying build/lib.linux-ppc64le-2.7/scipy/integrate/_ivp/base.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/integrate/_ivp copying build/lib.linux-ppc64le-2.7/scipy/integrate/_ivp/common.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/integrate/_ivp copying build/lib.linux-ppc64le-2.7/scipy/integrate/_ivp/ivp.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/integrate/_ivp copying build/lib.linux-ppc64le-2.7/scipy/integrate/_ivp/lsoda.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/integrate/_ivp copying build/lib.linux-ppc64le-2.7/scipy/integrate/_ivp/radau.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/integrate/_ivp copying build/lib.linux-ppc64le-2.7/scipy/integrate/_quadpack.so -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/integrate copying build/lib.linux-ppc64le-2.7/scipy/integrate/odepack.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/integrate copying build/lib.linux-ppc64le-2.7/scipy/integrate/vode.so -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/integrate copying build/lib.linux-ppc64le-2.7/scipy/integrate/_dop.so -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/integrate copying build/lib.linux-ppc64le-2.7/scipy/integrate/_bvp.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/integrate copying build/lib.linux-ppc64le-2.7/scipy/integrate/_ode.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/integrate copying build/lib.linux-ppc64le-2.7/scipy/integrate/setup.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/integrate copying build/lib.linux-ppc64le-2.7/scipy/integrate/_test_odeint_banded.so -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/integrate creating /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/misc copying build/lib.linux-ppc64le-2.7/scipy/misc/__init__.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/misc copying build/lib.linux-ppc64le-2.7/scipy/misc/pilutil.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/misc copying build/lib.linux-ppc64le-2.7/scipy/misc/doccer.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/misc copying build/lib.linux-ppc64le-2.7/scipy/misc/setup.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/misc copying build/lib.linux-ppc64le-2.7/scipy/misc/common.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/misc creating /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/interpolate copying build/lib.linux-ppc64le-2.7/scipy/interpolate/interpnd.so -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/interpolate copying build/lib.linux-ppc64le-2.7/scipy/interpolate/rbf.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/interpolate copying build/lib.linux-ppc64le-2.7/scipy/interpolate/_ppoly.so -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/interpolate copying build/lib.linux-ppc64le-2.7/scipy/interpolate/interpnd_info.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/interpolate copying build/lib.linux-ppc64le-2.7/scipy/interpolate/ndgriddata.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/interpolate copying build/lib.linux-ppc64le-2.7/scipy/interpolate/_fitpack_impl.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/interpolate copying build/lib.linux-ppc64le-2.7/scipy/interpolate/__init__.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/interpolate copying build/lib.linux-ppc64le-2.7/scipy/interpolate/_fitpack.so -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/interpolate copying build/lib.linux-ppc64le-2.7/scipy/interpolate/interpolate_wrapper.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/interpolate copying build/lib.linux-ppc64le-2.7/scipy/interpolate/_cubic.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/interpolate copying build/lib.linux-ppc64le-2.7/scipy/interpolate/_bsplines.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/interpolate copying build/lib.linux-ppc64le-2.7/scipy/interpolate/polyint.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/interpolate copying build/lib.linux-ppc64le-2.7/scipy/interpolate/fitpack2.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/interpolate copying build/lib.linux-ppc64le-2.7/scipy/interpolate/_pade.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/interpolate copying build/lib.linux-ppc64le-2.7/scipy/interpolate/setup.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/interpolate copying build/lib.linux-ppc64le-2.7/scipy/interpolate/dfitpack.so -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/interpolate copying build/lib.linux-ppc64le-2.7/scipy/interpolate/_bspl.so -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/interpolate copying build/lib.linux-ppc64le-2.7/scipy/interpolate/interpolate.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/interpolate copying build/lib.linux-ppc64le-2.7/scipy/interpolate/fitpack.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/interpolate copying build/lib.linux-ppc64le-2.7/scipy/interpolate/_interpolate.so -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/interpolate creating /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/special copying build/lib.linux-ppc64le-2.7/scipy/special/_mptestutils.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/special copying build/lib.linux-ppc64le-2.7/scipy/special/basic.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/special copying build/lib.linux-ppc64le-2.7/scipy/special/add_newdocs.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/special copying build/lib.linux-ppc64le-2.7/scipy/special/specfun.so -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/special copying build/lib.linux-ppc64le-2.7/scipy/special/lambertw.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/special copying build/lib.linux-ppc64le-2.7/scipy/special/__init__.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/special copying build/lib.linux-ppc64le-2.7/scipy/special/_comb.so -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/special copying build/lib.linux-ppc64le-2.7/scipy/special/_spherical_bessel.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/special copying build/lib.linux-ppc64le-2.7/scipy/special/_logsumexp.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/special copying build/lib.linux-ppc64le-2.7/scipy/special/_testutils.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/special copying build/lib.linux-ppc64le-2.7/scipy/special/orthogonal.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/special copying build/lib.linux-ppc64le-2.7/scipy/special/_ellip_harm_2.so -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/special copying build/lib.linux-ppc64le-2.7/scipy/special/_ufuncs.so -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/special copying build/lib.linux-ppc64le-2.7/scipy/special/setup.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/special copying build/lib.linux-ppc64le-2.7/scipy/special/_test_round.so -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/special copying build/lib.linux-ppc64le-2.7/scipy/special/spfun_stats.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/special copying build/lib.linux-ppc64le-2.7/scipy/special/cython_special.so -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/special copying build/lib.linux-ppc64le-2.7/scipy/special/_generate_pyx.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/special copying build/lib.linux-ppc64le-2.7/scipy/special/sf_error.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/special creating /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/special/_precompute copying build/lib.linux-ppc64le-2.7/scipy/special/_precompute/gammainc_data.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/special/_precompute copying build/lib.linux-ppc64le-2.7/scipy/special/_precompute/utils.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/special/_precompute copying build/lib.linux-ppc64le-2.7/scipy/special/_precompute/__init__.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/special/_precompute copying build/lib.linux-ppc64le-2.7/scipy/special/_precompute/expn_asy.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/special/_precompute copying build/lib.linux-ppc64le-2.7/scipy/special/_precompute/loggamma.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/special/_precompute copying build/lib.linux-ppc64le-2.7/scipy/special/_precompute/setup.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/special/_precompute copying build/lib.linux-ppc64le-2.7/scipy/special/_precompute/gammainc_asy.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/special/_precompute copying build/lib.linux-ppc64le-2.7/scipy/special/_ellip_harm.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/special copying build/lib.linux-ppc64le-2.7/scipy/special/_ufuncs_cxx.so -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/special copying build/lib.linux-ppc64le-2.7/scipy/__config__.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy creating /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/_lib copying build/lib.linux-ppc64le-2.7/scipy/_lib/_tmpdirs.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/_lib copying build/lib.linux-ppc64le-2.7/scipy/_lib/_numpy_compat.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/_lib copying build/lib.linux-ppc64le-2.7/scipy/_lib/messagestream.so -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/_lib copying build/lib.linux-ppc64le-2.7/scipy/_lib/_version.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/_lib copying build/lib.linux-ppc64le-2.7/scipy/_lib/__init__.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/_lib copying build/lib.linux-ppc64le-2.7/scipy/_lib/_util.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/_lib copying build/lib.linux-ppc64le-2.7/scipy/_lib/_threadsafety.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/_lib copying build/lib.linux-ppc64le-2.7/scipy/_lib/_testutils.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/_lib copying build/lib.linux-ppc64le-2.7/scipy/_lib/decorator.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/_lib copying build/lib.linux-ppc64le-2.7/scipy/_lib/_ccallback.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/_lib copying build/lib.linux-ppc64le-2.7/scipy/_lib/setup.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/_lib copying build/lib.linux-ppc64le-2.7/scipy/_lib/_ccallback_c.so -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/_lib copying build/lib.linux-ppc64le-2.7/scipy/_lib/_gcutils.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/_lib copying build/lib.linux-ppc64le-2.7/scipy/_lib/_test_ccallback.so -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/_lib copying build/lib.linux-ppc64le-2.7/scipy/_lib/_fpumode.so -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/_lib copying build/lib.linux-ppc64le-2.7/scipy/__init__.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy creating /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/constants copying build/lib.linux-ppc64le-2.7/scipy/constants/constants.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/constants copying build/lib.linux-ppc64le-2.7/scipy/constants/__init__.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/constants copying build/lib.linux-ppc64le-2.7/scipy/constants/codata.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/constants copying build/lib.linux-ppc64le-2.7/scipy/constants/setup.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/constants creating /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/ndimage copying build/lib.linux-ppc64le-2.7/scipy/ndimage/_ni_support.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/ndimage copying build/lib.linux-ppc64le-2.7/scipy/ndimage/_nd_image.so -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/ndimage copying build/lib.linux-ppc64le-2.7/scipy/ndimage/fourier.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/ndimage copying build/lib.linux-ppc64le-2.7/scipy/ndimage/measurements.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/ndimage copying build/lib.linux-ppc64le-2.7/scipy/ndimage/filters.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/ndimage copying build/lib.linux-ppc64le-2.7/scipy/ndimage/morphology.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/ndimage copying build/lib.linux-ppc64le-2.7/scipy/ndimage/_ctest.so -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/ndimage copying build/lib.linux-ppc64le-2.7/scipy/ndimage/__init__.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/ndimage copying build/lib.linux-ppc64le-2.7/scipy/ndimage/_ni_label.so -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/ndimage copying build/lib.linux-ppc64le-2.7/scipy/ndimage/io.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/ndimage copying build/lib.linux-ppc64le-2.7/scipy/ndimage/_ctest_oldapi.so -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/ndimage copying build/lib.linux-ppc64le-2.7/scipy/ndimage/setup.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/ndimage copying build/lib.linux-ppc64le-2.7/scipy/ndimage/_cytest.so -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/ndimage copying build/lib.linux-ppc64le-2.7/scipy/ndimage/interpolation.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/ndimage copying build/lib.linux-ppc64le-2.7/scipy/conftest.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy creating /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/optimize copying build/lib.linux-ppc64le-2.7/scipy/optimize/_minpack.so -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/optimize copying build/lib.linux-ppc64le-2.7/scipy/optimize/lbfgsb.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/optimize copying build/lib.linux-ppc64le-2.7/scipy/optimize/nnls.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/optimize copying build/lib.linux-ppc64le-2.7/scipy/optimize/_zeros.so -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/optimize copying build/lib.linux-ppc64le-2.7/scipy/optimize/_trustregion_dogleg.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/optimize copying build/lib.linux-ppc64le-2.7/scipy/optimize/cobyla.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/optimize copying build/lib.linux-ppc64le-2.7/scipy/optimize/_differentialevolution.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/optimize copying build/lib.linux-ppc64le-2.7/scipy/optimize/_hungarian.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/optimize copying build/lib.linux-ppc64le-2.7/scipy/optimize/_slsqp.so -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/optimize copying build/lib.linux-ppc64le-2.7/scipy/optimize/_numdiff.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/optimize copying build/lib.linux-ppc64le-2.7/scipy/optimize/__init__.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/optimize copying build/lib.linux-ppc64le-2.7/scipy/optimize/minpack2.so -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/optimize copying build/lib.linux-ppc64le-2.7/scipy/optimize/_cobyla.so -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/optimize copying build/lib.linux-ppc64le-2.7/scipy/optimize/_group_columns.so -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/optimize copying build/lib.linux-ppc64le-2.7/scipy/optimize/_linprog.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/optimize copying build/lib.linux-ppc64le-2.7/scipy/optimize/_trustregion_exact.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/optimize copying build/lib.linux-ppc64le-2.7/scipy/optimize/tnc.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/optimize copying build/lib.linux-ppc64le-2.7/scipy/optimize/nonlin.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/optimize copying build/lib.linux-ppc64le-2.7/scipy/optimize/_linprog_ip.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/optimize copying build/lib.linux-ppc64le-2.7/scipy/optimize/_lbfgsb.so -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/optimize copying build/lib.linux-ppc64le-2.7/scipy/optimize/slsqp.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/optimize creating /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/optimize/_trlib copying build/lib.linux-ppc64le-2.7/scipy/optimize/_trlib/__init__.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/optimize/_trlib copying build/lib.linux-ppc64le-2.7/scipy/optimize/_trlib/_trlib.so -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/optimize/_trlib copying build/lib.linux-ppc64le-2.7/scipy/optimize/_trlib/setup.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/optimize/_trlib copying build/lib.linux-ppc64le-2.7/scipy/optimize/_minimize.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/optimize copying build/lib.linux-ppc64le-2.7/scipy/optimize/_trustregion_krylov.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/optimize copying build/lib.linux-ppc64le-2.7/scipy/optimize/_tstutils.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/optimize copying build/lib.linux-ppc64le-2.7/scipy/optimize/_root.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/optimize copying build/lib.linux-ppc64le-2.7/scipy/optimize/_nnls.so -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/optimize copying build/lib.linux-ppc64le-2.7/scipy/optimize/setup.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/optimize copying build/lib.linux-ppc64le-2.7/scipy/optimize/_remove_redundancy.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/optimize copying build/lib.linux-ppc64le-2.7/scipy/optimize/_spectral.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/optimize copying build/lib.linux-ppc64le-2.7/scipy/optimize/_basinhopping.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/optimize creating /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/optimize/_lsq copying build/lib.linux-ppc64le-2.7/scipy/optimize/_lsq/trf_linear.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/optimize/_lsq copying build/lib.linux-ppc64le-2.7/scipy/optimize/_lsq/least_squares.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/optimize/_lsq copying build/lib.linux-ppc64le-2.7/scipy/optimize/_lsq/dogbox.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/optimize/_lsq copying build/lib.linux-ppc64le-2.7/scipy/optimize/_lsq/__init__.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/optimize/_lsq copying build/lib.linux-ppc64le-2.7/scipy/optimize/_lsq/givens_elimination.so -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/optimize/_lsq copying build/lib.linux-ppc64le-2.7/scipy/optimize/_lsq/lsq_linear.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/optimize/_lsq copying build/lib.linux-ppc64le-2.7/scipy/optimize/_lsq/trf.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/optimize/_lsq copying build/lib.linux-ppc64le-2.7/scipy/optimize/_lsq/bvls.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/optimize/_lsq copying build/lib.linux-ppc64le-2.7/scipy/optimize/_lsq/setup.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/optimize/_lsq copying build/lib.linux-ppc64le-2.7/scipy/optimize/_lsq/common.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/optimize/_lsq copying build/lib.linux-ppc64le-2.7/scipy/optimize/moduleTNC.so -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/optimize copying build/lib.linux-ppc64le-2.7/scipy/optimize/minpack.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/optimize copying build/lib.linux-ppc64le-2.7/scipy/optimize/_trustregion.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/optimize copying build/lib.linux-ppc64le-2.7/scipy/optimize/optimize.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/optimize copying build/lib.linux-ppc64le-2.7/scipy/optimize/zeros.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/optimize copying build/lib.linux-ppc64le-2.7/scipy/optimize/_trustregion_ncg.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/optimize copying build/lib.linux-ppc64le-2.7/scipy/optimize/linesearch.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/optimize creating /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/stats copying build/lib.linux-ppc64le-2.7/scipy/stats/contingency.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/stats copying build/lib.linux-ppc64le-2.7/scipy/stats/_stats.so -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/stats copying build/lib.linux-ppc64le-2.7/scipy/stats/mstats.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/stats copying build/lib.linux-ppc64le-2.7/scipy/stats/_multivariate.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/stats copying build/lib.linux-ppc64le-2.7/scipy/stats/statlib.so -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/stats copying build/lib.linux-ppc64le-2.7/scipy/stats/mvn.so -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/stats copying build/lib.linux-ppc64le-2.7/scipy/stats/mstats_basic.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/stats copying build/lib.linux-ppc64le-2.7/scipy/stats/mstats_extras.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/stats copying build/lib.linux-ppc64le-2.7/scipy/stats/morestats.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/stats copying build/lib.linux-ppc64le-2.7/scipy/stats/_tukeylambda_stats.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/stats copying build/lib.linux-ppc64le-2.7/scipy/stats/__init__.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/stats copying build/lib.linux-ppc64le-2.7/scipy/stats/vonmises.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/stats copying build/lib.linux-ppc64le-2.7/scipy/stats/distributions.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/stats copying build/lib.linux-ppc64le-2.7/scipy/stats/_discrete_distns.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/stats copying build/lib.linux-ppc64le-2.7/scipy/stats/_stats_mstats_common.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/stats copying build/lib.linux-ppc64le-2.7/scipy/stats/_distr_params.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/stats copying build/lib.linux-ppc64le-2.7/scipy/stats/_constants.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/stats copying build/lib.linux-ppc64le-2.7/scipy/stats/setup.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/stats copying build/lib.linux-ppc64le-2.7/scipy/stats/kde.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/stats copying build/lib.linux-ppc64le-2.7/scipy/stats/_continuous_distns.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/stats copying build/lib.linux-ppc64le-2.7/scipy/stats/_binned_statistic.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/stats copying build/lib.linux-ppc64le-2.7/scipy/stats/stats.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/stats copying build/lib.linux-ppc64le-2.7/scipy/stats/_distn_infrastructure.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/stats creating /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/sparse copying build/lib.linux-ppc64le-2.7/scipy/sparse/coo.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/sparse copying build/lib.linux-ppc64le-2.7/scipy/sparse/compressed.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/sparse copying build/lib.linux-ppc64le-2.7/scipy/sparse/csc.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/sparse copying build/lib.linux-ppc64le-2.7/scipy/sparse/sputils.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/sparse copying build/lib.linux-ppc64le-2.7/scipy/sparse/spfuncs.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/sparse copying build/lib.linux-ppc64le-2.7/scipy/sparse/_matrix_io.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/sparse creating /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/sparse/csgraph copying build/lib.linux-ppc64le-2.7/scipy/sparse/csgraph/_laplacian.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/sparse/csgraph copying build/lib.linux-ppc64le-2.7/scipy/sparse/csgraph/__init__.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/sparse/csgraph copying build/lib.linux-ppc64le-2.7/scipy/sparse/csgraph/_tools.so -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/sparse/csgraph copying build/lib.linux-ppc64le-2.7/scipy/sparse/csgraph/_min_spanning_tree.so -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/sparse/csgraph copying build/lib.linux-ppc64le-2.7/scipy/sparse/csgraph/setup.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/sparse/csgraph copying build/lib.linux-ppc64le-2.7/scipy/sparse/csgraph/_validation.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/sparse/csgraph copying build/lib.linux-ppc64le-2.7/scipy/sparse/csgraph/_reordering.so -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/sparse/csgraph copying build/lib.linux-ppc64le-2.7/scipy/sparse/csgraph/_traversal.so -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/sparse/csgraph copying build/lib.linux-ppc64le-2.7/scipy/sparse/csgraph/_shortest_path.so -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/sparse/csgraph copying build/lib.linux-ppc64le-2.7/scipy/sparse/sparsetools.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/sparse copying build/lib.linux-ppc64le-2.7/scipy/sparse/construct.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/sparse copying build/lib.linux-ppc64le-2.7/scipy/sparse/data.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/sparse copying build/lib.linux-ppc64le-2.7/scipy/sparse/_sparsetools.so -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/sparse copying build/lib.linux-ppc64le-2.7/scipy/sparse/__init__.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/sparse copying build/lib.linux-ppc64le-2.7/scipy/sparse/extract.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/sparse copying build/lib.linux-ppc64le-2.7/scipy/sparse/dok.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/sparse copying build/lib.linux-ppc64le-2.7/scipy/sparse/csr.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/sparse copying build/lib.linux-ppc64le-2.7/scipy/sparse/generate_sparsetools.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/sparse copying build/lib.linux-ppc64le-2.7/scipy/sparse/lil.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/sparse copying build/lib.linux-ppc64le-2.7/scipy/sparse/bsr.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/sparse copying build/lib.linux-ppc64le-2.7/scipy/sparse/base.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/sparse copying build/lib.linux-ppc64le-2.7/scipy/sparse/_csparsetools.so -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/sparse copying build/lib.linux-ppc64le-2.7/scipy/sparse/dia.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/sparse copying build/lib.linux-ppc64le-2.7/scipy/sparse/setup.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/sparse creating /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/sparse/linalg copying build/lib.linux-ppc64le-2.7/scipy/sparse/linalg/_norm.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/sparse/linalg copying build/lib.linux-ppc64le-2.7/scipy/sparse/linalg/matfuncs.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/sparse/linalg copying build/lib.linux-ppc64le-2.7/scipy/sparse/linalg/__init__.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/sparse/linalg copying build/lib.linux-ppc64le-2.7/scipy/sparse/linalg/_expm_multiply.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/sparse/linalg creating /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/sparse/linalg/eigen copying build/lib.linux-ppc64le-2.7/scipy/sparse/linalg/eigen/__init__.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/sparse/linalg/eigen creating /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/sparse/linalg/eigen/lobpcg copying build/lib.linux-ppc64le-2.7/scipy/sparse/linalg/eigen/lobpcg/__init__.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/sparse/linalg/eigen/lobpcg copying build/lib.linux-ppc64le-2.7/scipy/sparse/linalg/eigen/lobpcg/setup.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/sparse/linalg/eigen/lobpcg copying build/lib.linux-ppc64le-2.7/scipy/sparse/linalg/eigen/lobpcg/lobpcg.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/sparse/linalg/eigen/lobpcg creating /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/sparse/linalg/eigen/arpack copying build/lib.linux-ppc64le-2.7/scipy/sparse/linalg/eigen/arpack/__init__.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/sparse/linalg/eigen/arpack copying build/lib.linux-ppc64le-2.7/scipy/sparse/linalg/eigen/arpack/_arpack.so -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/sparse/linalg/eigen/arpack copying build/lib.linux-ppc64le-2.7/scipy/sparse/linalg/eigen/arpack/setup.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/sparse/linalg/eigen/arpack copying build/lib.linux-ppc64le-2.7/scipy/sparse/linalg/eigen/arpack/arpack.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/sparse/linalg/eigen/arpack copying build/lib.linux-ppc64le-2.7/scipy/sparse/linalg/eigen/setup.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/sparse/linalg/eigen copying build/lib.linux-ppc64le-2.7/scipy/sparse/linalg/_onenormest.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/sparse/linalg creating /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/sparse/linalg/dsolve copying build/lib.linux-ppc64le-2.7/scipy/sparse/linalg/dsolve/linsolve.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/sparse/linalg/dsolve copying build/lib.linux-ppc64le-2.7/scipy/sparse/linalg/dsolve/_add_newdocs.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/sparse/linalg/dsolve copying build/lib.linux-ppc64le-2.7/scipy/sparse/linalg/dsolve/__init__.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/sparse/linalg/dsolve copying build/lib.linux-ppc64le-2.7/scipy/sparse/linalg/dsolve/_superlu.so -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/sparse/linalg/dsolve copying build/lib.linux-ppc64le-2.7/scipy/sparse/linalg/dsolve/setup.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/sparse/linalg/dsolve copying build/lib.linux-ppc64le-2.7/scipy/sparse/linalg/setup.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/sparse/linalg copying build/lib.linux-ppc64le-2.7/scipy/sparse/linalg/interface.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/sparse/linalg creating /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/sparse/linalg/isolve copying build/lib.linux-ppc64le-2.7/scipy/sparse/linalg/isolve/lgmres.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/sparse/linalg/isolve copying build/lib.linux-ppc64le-2.7/scipy/sparse/linalg/isolve/iterative.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/sparse/linalg/isolve copying build/lib.linux-ppc64le-2.7/scipy/sparse/linalg/isolve/minres.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/sparse/linalg/isolve copying build/lib.linux-ppc64le-2.7/scipy/sparse/linalg/isolve/utils.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/sparse/linalg/isolve copying build/lib.linux-ppc64le-2.7/scipy/sparse/linalg/isolve/__init__.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/sparse/linalg/isolve copying build/lib.linux-ppc64le-2.7/scipy/sparse/linalg/isolve/_iterative.so -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/sparse/linalg/isolve copying build/lib.linux-ppc64le-2.7/scipy/sparse/linalg/isolve/lsqr.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/sparse/linalg/isolve copying build/lib.linux-ppc64le-2.7/scipy/sparse/linalg/isolve/lsmr.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/sparse/linalg/isolve copying build/lib.linux-ppc64le-2.7/scipy/sparse/linalg/isolve/setup.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/sparse/linalg/isolve copying build/lib.linux-ppc64le-2.7/scipy/sparse/linalg/isolve/_gcrotmk.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/sparse/linalg/isolve creating /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/signal copying build/lib.linux-ppc64le-2.7/scipy/signal/windows.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/signal copying build/lib.linux-ppc64le-2.7/scipy/signal/wavelets.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/signal copying build/lib.linux-ppc64le-2.7/scipy/signal/_arraytools.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/signal copying build/lib.linux-ppc64le-2.7/scipy/signal/ltisys.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/signal copying build/lib.linux-ppc64le-2.7/scipy/signal/spectral.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/signal copying build/lib.linux-ppc64le-2.7/scipy/signal/_peak_finding.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/signal copying build/lib.linux-ppc64le-2.7/scipy/signal/filter_design.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/signal copying build/lib.linux-ppc64le-2.7/scipy/signal/_spectral.so -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/signal copying build/lib.linux-ppc64le-2.7/scipy/signal/__init__.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/signal copying build/lib.linux-ppc64le-2.7/scipy/signal/waveforms.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/signal copying build/lib.linux-ppc64le-2.7/scipy/signal/fir_filter_design.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/signal copying build/lib.linux-ppc64le-2.7/scipy/signal/spline.so -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/signal copying build/lib.linux-ppc64le-2.7/scipy/signal/sigtools.so -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/signal copying build/lib.linux-ppc64le-2.7/scipy/signal/lti_conversion.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/signal copying build/lib.linux-ppc64le-2.7/scipy/signal/_max_len_seq.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/signal copying build/lib.linux-ppc64le-2.7/scipy/signal/setup.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/signal copying build/lib.linux-ppc64le-2.7/scipy/signal/bsplines.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/signal copying build/lib.linux-ppc64le-2.7/scipy/signal/_upfirdn.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/signal copying build/lib.linux-ppc64le-2.7/scipy/signal/_upfirdn_apply.so -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/signal copying build/lib.linux-ppc64le-2.7/scipy/signal/_max_len_seq_inner.so -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/signal copying build/lib.linux-ppc64le-2.7/scipy/signal/_savitzky_golay.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/signal copying build/lib.linux-ppc64le-2.7/scipy/signal/signaltools.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/signal copying build/lib.linux-ppc64le-2.7/scipy/setup.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy creating /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/_build_utils copying build/lib.linux-ppc64le-2.7/scipy/_build_utils/__init__.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/_build_utils copying build/lib.linux-ppc64le-2.7/scipy/_build_utils/_fortran.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/_build_utils creating /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/spatial copying build/lib.linux-ppc64le-2.7/scipy/spatial/_procrustes.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/spatial copying build/lib.linux-ppc64le-2.7/scipy/spatial/kdtree.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/spatial copying build/lib.linux-ppc64le-2.7/scipy/spatial/distance.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/spatial copying build/lib.linux-ppc64le-2.7/scipy/spatial/ckdtree.so -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/spatial copying build/lib.linux-ppc64le-2.7/scipy/spatial/__init__.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/spatial copying build/lib.linux-ppc64le-2.7/scipy/spatial/_distance_wrap.so -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/spatial copying build/lib.linux-ppc64le-2.7/scipy/spatial/qhull.so -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/spatial copying build/lib.linux-ppc64le-2.7/scipy/spatial/_plotutils.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/spatial copying build/lib.linux-ppc64le-2.7/scipy/spatial/_spherical_voronoi.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/spatial copying build/lib.linux-ppc64le-2.7/scipy/spatial/setup.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/spatial copying build/lib.linux-ppc64le-2.7/scipy/spatial/_hausdorff.so -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/spatial copying build/lib.linux-ppc64le-2.7/scipy/spatial/_voronoi.so -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/spatial copying build/lib.linux-ppc64le-2.7/scipy/_distributor_init.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy creating /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/fftpack copying build/lib.linux-ppc64le-2.7/scipy/fftpack/basic.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/fftpack copying build/lib.linux-ppc64le-2.7/scipy/fftpack/convolve.so -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/fftpack copying build/lib.linux-ppc64le-2.7/scipy/fftpack/__init__.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/fftpack copying build/lib.linux-ppc64le-2.7/scipy/fftpack/realtransforms.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/fftpack copying build/lib.linux-ppc64le-2.7/scipy/fftpack/pseudo_diffs.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/fftpack copying build/lib.linux-ppc64le-2.7/scipy/fftpack/_fftpack.so -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/fftpack copying build/lib.linux-ppc64le-2.7/scipy/fftpack/setup.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/fftpack copying build/lib.linux-ppc64le-2.7/scipy/fftpack/helper.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/fftpack copying build/lib.linux-ppc64le-2.7/scipy/version.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy creating /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io copying build/lib.linux-ppc64le-2.7/scipy/io/idl.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io copying build/lib.linux-ppc64le-2.7/scipy/io/netcdf.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io copying build/lib.linux-ppc64le-2.7/scipy/io/mmio.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io copying build/lib.linux-ppc64le-2.7/scipy/io/__init__.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io copying build/lib.linux-ppc64le-2.7/scipy/io/wavfile.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io copying build/lib.linux-ppc64le-2.7/scipy/io/_fortran.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io copying build/lib.linux-ppc64le-2.7/scipy/io/setup.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io creating /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/harwell_boeing copying build/lib.linux-ppc64le-2.7/scipy/io/harwell_boeing/_fortran_format_parser.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/harwell_boeing copying build/lib.linux-ppc64le-2.7/scipy/io/harwell_boeing/__init__.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/harwell_boeing copying build/lib.linux-ppc64le-2.7/scipy/io/harwell_boeing/setup.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/harwell_boeing copying build/lib.linux-ppc64le-2.7/scipy/io/harwell_boeing/hb.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/harwell_boeing creating /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/matlab copying build/lib.linux-ppc64le-2.7/scipy/io/matlab/streams.so -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/matlab copying build/lib.linux-ppc64le-2.7/scipy/io/matlab/mio5_utils.so -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/matlab copying build/lib.linux-ppc64le-2.7/scipy/io/matlab/mio.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/matlab copying build/lib.linux-ppc64le-2.7/scipy/io/matlab/__init__.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/matlab copying build/lib.linux-ppc64le-2.7/scipy/io/matlab/byteordercodes.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/matlab copying build/lib.linux-ppc64le-2.7/scipy/io/matlab/mio5.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/matlab copying build/lib.linux-ppc64le-2.7/scipy/io/matlab/mio5_params.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/matlab copying build/lib.linux-ppc64le-2.7/scipy/io/matlab/mio_utils.so -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/matlab copying build/lib.linux-ppc64le-2.7/scipy/io/matlab/mio4.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/matlab copying build/lib.linux-ppc64le-2.7/scipy/io/matlab/setup.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/matlab copying build/lib.linux-ppc64le-2.7/scipy/io/matlab/miobase.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/matlab copying build/lib.linux-ppc64le-2.7/scipy/io/_test_fortran.so -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io creating /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/arff copying build/lib.linux-ppc64le-2.7/scipy/io/arff/__init__.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/arff copying build/lib.linux-ppc64le-2.7/scipy/io/arff/setup.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/arff copying build/lib.linux-ppc64le-2.7/scipy/io/arff/arffread.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/arff creating /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/linalg copying build/lib.linux-ppc64le-2.7/scipy/linalg/basic.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/linalg copying build/lib.linux-ppc64le-2.7/scipy/linalg/misc.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/linalg copying build/lib.linux-ppc64le-2.7/scipy/linalg/_expm_frechet.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/linalg copying build/lib.linux-ppc64le-2.7/scipy/linalg/linalg_version.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/linalg copying build/lib.linux-ppc64le-2.7/scipy/linalg/_decomp_qz.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/linalg copying build/lib.linux-ppc64le-2.7/scipy/linalg/_flinalg.so -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/linalg copying build/lib.linux-ppc64le-2.7/scipy/linalg/cython_lapack.so -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/linalg copying build/lib.linux-ppc64le-2.7/scipy/linalg/decomp_schur.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/linalg copying build/lib.linux-ppc64le-2.7/scipy/linalg/_procrustes.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/linalg copying build/lib.linux-ppc64le-2.7/scipy/linalg/lapack.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/linalg copying build/lib.linux-ppc64le-2.7/scipy/linalg/decomp_lu.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/linalg copying build/lib.linux-ppc64le-2.7/scipy/linalg/blas.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/linalg copying build/lib.linux-ppc64le-2.7/scipy/linalg/matfuncs.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/linalg copying build/lib.linux-ppc64le-2.7/scipy/linalg/_fblas.so -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/linalg copying build/lib.linux-ppc64le-2.7/scipy/linalg/__init__.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/linalg copying build/lib.linux-ppc64le-2.7/scipy/linalg/_matfuncs_sqrtm.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/linalg copying build/lib.linux-ppc64le-2.7/scipy/linalg/_decomp_update.so -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/linalg copying build/lib.linux-ppc64le-2.7/scipy/linalg/_solvers.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/linalg copying build/lib.linux-ppc64le-2.7/scipy/linalg/decomp.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/linalg copying build/lib.linux-ppc64le-2.7/scipy/linalg/_testutils.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/linalg copying build/lib.linux-ppc64le-2.7/scipy/linalg/_decomp_polar.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/linalg copying build/lib.linux-ppc64le-2.7/scipy/linalg/_cython_signature_generator.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/linalg copying build/lib.linux-ppc64le-2.7/scipy/linalg/special_matrices.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/linalg copying build/lib.linux-ppc64le-2.7/scipy/linalg/cython_blas.so -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/linalg copying build/lib.linux-ppc64le-2.7/scipy/linalg/flinalg.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/linalg copying build/lib.linux-ppc64le-2.7/scipy/linalg/_solve_toeplitz.so -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/linalg copying build/lib.linux-ppc64le-2.7/scipy/linalg/_matfuncs_inv_ssq.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/linalg copying build/lib.linux-ppc64le-2.7/scipy/linalg/setup.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/linalg copying build/lib.linux-ppc64le-2.7/scipy/linalg/decomp_qr.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/linalg copying build/lib.linux-ppc64le-2.7/scipy/linalg/_sketches.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/linalg copying build/lib.linux-ppc64le-2.7/scipy/linalg/interpolative.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/linalg copying build/lib.linux-ppc64le-2.7/scipy/linalg/_generate_pyx.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/linalg copying build/lib.linux-ppc64le-2.7/scipy/linalg/decomp_cholesky.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/linalg copying build/lib.linux-ppc64le-2.7/scipy/linalg/decomp_svd.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/linalg copying build/lib.linux-ppc64le-2.7/scipy/linalg/_interpolative.so -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/linalg copying build/lib.linux-ppc64le-2.7/scipy/linalg/_interpolative_backend.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/linalg copying build/lib.linux-ppc64le-2.7/scipy/linalg/_flapack.so -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/linalg creating /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/cluster copying build/lib.linux-ppc64le-2.7/scipy/cluster/_vq.so -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/cluster copying build/lib.linux-ppc64le-2.7/scipy/cluster/__init__.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/cluster copying build/lib.linux-ppc64le-2.7/scipy/cluster/vq.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/cluster copying build/lib.linux-ppc64le-2.7/scipy/cluster/hierarchy.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/cluster copying build/lib.linux-ppc64le-2.7/scipy/cluster/setup.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/cluster copying build/lib.linux-ppc64le-2.7/scipy/cluster/_optimal_leaf_ordering.so -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/cluster copying build/lib.linux-ppc64le-2.7/scipy/cluster/_hierarchy.so -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/cluster creating /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/odr copying build/lib.linux-ppc64le-2.7/scipy/odr/add_newdocs.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/odr copying build/lib.linux-ppc64le-2.7/scipy/odr/models.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/odr copying build/lib.linux-ppc64le-2.7/scipy/odr/__init__.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/odr copying build/lib.linux-ppc64le-2.7/scipy/odr/odrpack.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/odr copying build/lib.linux-ppc64le-2.7/scipy/odr/__odrpack.so -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/odr copying build/lib.linux-ppc64le-2.7/scipy/odr/setup.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/odr byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/integrate/quadpack.py to quadpack.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/integrate/quadrature.py to quadrature.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/integrate/__init__.py to __init__.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/integrate/_ivp/bdf.py to bdf.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/integrate/_ivp/rk.py to rk.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/integrate/_ivp/__init__.py to __init__.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/integrate/_ivp/base.py to base.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/integrate/_ivp/common.py to common.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/integrate/_ivp/ivp.py to ivp.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/integrate/_ivp/lsoda.py to lsoda.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/integrate/_ivp/radau.py to radau.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/integrate/odepack.py to odepack.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/integrate/_bvp.py to _bvp.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/integrate/_ode.py to _ode.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/integrate/setup.py to setup.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/misc/__init__.py to __init__.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/misc/pilutil.py to pilutil.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/misc/doccer.py to doccer.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/misc/setup.py to setup.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/misc/common.py to common.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/interpolate/rbf.py to rbf.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/interpolate/interpnd_info.py to interpnd_info.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/interpolate/ndgriddata.py to ndgriddata.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/interpolate/_fitpack_impl.py to _fitpack_impl.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/interpolate/__init__.py to __init__.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/interpolate/interpolate_wrapper.py to interpolate_wrapper.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/interpolate/_cubic.py to _cubic.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/interpolate/_bsplines.py to _bsplines.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/interpolate/polyint.py to polyint.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/interpolate/fitpack2.py to fitpack2.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/interpolate/_pade.py to _pade.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/interpolate/setup.py to setup.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/interpolate/interpolate.py to interpolate.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/interpolate/fitpack.py to fitpack.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/special/_mptestutils.py to _mptestutils.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/special/basic.py to basic.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/special/add_newdocs.py to add_newdocs.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/special/lambertw.py to lambertw.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/special/__init__.py to __init__.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/special/_spherical_bessel.py to _spherical_bessel.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/special/_logsumexp.py to _logsumexp.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/special/_testutils.py to _testutils.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/special/orthogonal.py to orthogonal.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/special/setup.py to setup.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/special/spfun_stats.py to spfun_stats.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/special/_generate_pyx.py to _generate_pyx.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/special/sf_error.py to sf_error.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/special/_precompute/gammainc_data.py to gammainc_data.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/special/_precompute/utils.py to utils.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/special/_precompute/__init__.py to __init__.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/special/_precompute/expn_asy.py to expn_asy.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/special/_precompute/loggamma.py to loggamma.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/special/_precompute/setup.py to setup.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/special/_precompute/gammainc_asy.py to gammainc_asy.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/special/_ellip_harm.py to _ellip_harm.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/__config__.py to __config__.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/_lib/_tmpdirs.py to _tmpdirs.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/_lib/_numpy_compat.py to _numpy_compat.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/_lib/_version.py to _version.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/_lib/__init__.py to __init__.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/_lib/_util.py to _util.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/_lib/_threadsafety.py to _threadsafety.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/_lib/_testutils.py to _testutils.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/_lib/decorator.py to decorator.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/_lib/_ccallback.py to _ccallback.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/_lib/setup.py to setup.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/_lib/_gcutils.py to _gcutils.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/__init__.py to __init__.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/constants/constants.py to constants.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/constants/__init__.py to __init__.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/constants/codata.py to codata.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/constants/setup.py to setup.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/ndimage/_ni_support.py to _ni_support.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/ndimage/fourier.py to fourier.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/ndimage/measurements.py to measurements.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/ndimage/filters.py to filters.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/ndimage/morphology.py to morphology.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/ndimage/__init__.py to __init__.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/ndimage/io.py to io.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/ndimage/setup.py to setup.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/ndimage/interpolation.py to interpolation.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/conftest.py to conftest.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/optimize/lbfgsb.py to lbfgsb.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/optimize/nnls.py to nnls.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/optimize/_trustregion_dogleg.py to _trustregion_dogleg.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/optimize/cobyla.py to cobyla.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/optimize/_differentialevolution.py to _differentialevolution.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/optimize/_hungarian.py to _hungarian.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/optimize/_numdiff.py to _numdiff.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/optimize/__init__.py to __init__.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/optimize/_linprog.py to _linprog.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/optimize/_trustregion_exact.py to _trustregion_exact.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/optimize/tnc.py to tnc.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/optimize/nonlin.py to nonlin.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/optimize/_linprog_ip.py to _linprog_ip.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/optimize/slsqp.py to slsqp.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/optimize/_trlib/__init__.py to __init__.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/optimize/_trlib/setup.py to setup.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/optimize/_minimize.py to _minimize.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/optimize/_trustregion_krylov.py to _trustregion_krylov.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/optimize/_tstutils.py to _tstutils.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/optimize/_root.py to _root.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/optimize/setup.py to setup.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/optimize/_remove_redundancy.py to _remove_redundancy.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/optimize/_spectral.py to _spectral.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/optimize/_basinhopping.py to _basinhopping.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/optimize/_lsq/trf_linear.py to trf_linear.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/optimize/_lsq/least_squares.py to least_squares.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/optimize/_lsq/dogbox.py to dogbox.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/optimize/_lsq/__init__.py to __init__.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/optimize/_lsq/lsq_linear.py to lsq_linear.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/optimize/_lsq/trf.py to trf.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/optimize/_lsq/bvls.py to bvls.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/optimize/_lsq/setup.py to setup.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/optimize/_lsq/common.py to common.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/optimize/minpack.py to minpack.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/optimize/_trustregion.py to _trustregion.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/optimize/optimize.py to optimize.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/optimize/zeros.py to zeros.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/optimize/_trustregion_ncg.py to _trustregion_ncg.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/optimize/linesearch.py to linesearch.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/stats/contingency.py to contingency.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/stats/mstats.py to mstats.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/stats/_multivariate.py to _multivariate.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/stats/mstats_basic.py to mstats_basic.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/stats/mstats_extras.py to mstats_extras.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/stats/morestats.py to morestats.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/stats/_tukeylambda_stats.py to _tukeylambda_stats.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/stats/__init__.py to __init__.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/stats/vonmises.py to vonmises.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/stats/distributions.py to distributions.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/stats/_discrete_distns.py to _discrete_distns.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/stats/_stats_mstats_common.py to _stats_mstats_common.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/stats/_distr_params.py to _distr_params.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/stats/_constants.py to _constants.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/stats/setup.py to setup.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/stats/kde.py to kde.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/stats/_continuous_distns.py to _continuous_distns.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/stats/_binned_statistic.py to _binned_statistic.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/stats/stats.py to stats.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/stats/_distn_infrastructure.py to _distn_infrastructure.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/sparse/coo.py to coo.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/sparse/compressed.py to compressed.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/sparse/csc.py to csc.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/sparse/sputils.py to sputils.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/sparse/spfuncs.py to spfuncs.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/sparse/_matrix_io.py to _matrix_io.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/sparse/csgraph/_laplacian.py to _laplacian.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/sparse/csgraph/__init__.py to __init__.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/sparse/csgraph/setup.py to setup.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/sparse/csgraph/_validation.py to _validation.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/sparse/sparsetools.py to sparsetools.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/sparse/construct.py to construct.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/sparse/data.py to data.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/sparse/__init__.py to __init__.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/sparse/extract.py to extract.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/sparse/dok.py to dok.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/sparse/csr.py to csr.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/sparse/generate_sparsetools.py to generate_sparsetools.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/sparse/lil.py to lil.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/sparse/bsr.py to bsr.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/sparse/base.py to base.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/sparse/dia.py to dia.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/sparse/setup.py to setup.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/sparse/linalg/_norm.py to _norm.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/sparse/linalg/matfuncs.py to matfuncs.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/sparse/linalg/__init__.py to __init__.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/sparse/linalg/_expm_multiply.py to _expm_multiply.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/sparse/linalg/eigen/__init__.py to __init__.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/sparse/linalg/eigen/lobpcg/__init__.py to __init__.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/sparse/linalg/eigen/lobpcg/setup.py to setup.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/sparse/linalg/eigen/lobpcg/lobpcg.py to lobpcg.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/sparse/linalg/eigen/arpack/__init__.py to __init__.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/sparse/linalg/eigen/arpack/setup.py to setup.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/sparse/linalg/eigen/arpack/arpack.py to arpack.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/sparse/linalg/eigen/setup.py to setup.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/sparse/linalg/_onenormest.py to _onenormest.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/sparse/linalg/dsolve/linsolve.py to linsolve.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/sparse/linalg/dsolve/_add_newdocs.py to _add_newdocs.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/sparse/linalg/dsolve/__init__.py to __init__.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/sparse/linalg/dsolve/setup.py to setup.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/sparse/linalg/setup.py to setup.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/sparse/linalg/interface.py to interface.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/sparse/linalg/isolve/lgmres.py to lgmres.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/sparse/linalg/isolve/iterative.py to iterative.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/sparse/linalg/isolve/minres.py to minres.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/sparse/linalg/isolve/utils.py to utils.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/sparse/linalg/isolve/__init__.py to __init__.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/sparse/linalg/isolve/lsqr.py to lsqr.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/sparse/linalg/isolve/lsmr.py to lsmr.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/sparse/linalg/isolve/setup.py to setup.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/sparse/linalg/isolve/_gcrotmk.py to _gcrotmk.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/signal/windows.py to windows.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/signal/wavelets.py to wavelets.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/signal/_arraytools.py to _arraytools.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/signal/ltisys.py to ltisys.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/signal/spectral.py to spectral.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/signal/_peak_finding.py to _peak_finding.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/signal/filter_design.py to filter_design.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/signal/__init__.py to __init__.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/signal/waveforms.py to waveforms.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/signal/fir_filter_design.py to fir_filter_design.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/signal/lti_conversion.py to lti_conversion.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/signal/_max_len_seq.py to _max_len_seq.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/signal/setup.py to setup.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/signal/bsplines.py to bsplines.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/signal/_upfirdn.py to _upfirdn.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/signal/_savitzky_golay.py to _savitzky_golay.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/signal/signaltools.py to signaltools.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/setup.py to setup.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/_build_utils/__init__.py to __init__.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/_build_utils/_fortran.py to _fortran.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/spatial/_procrustes.py to _procrustes.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/spatial/kdtree.py to kdtree.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/spatial/distance.py to distance.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/spatial/__init__.py to __init__.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/spatial/_plotutils.py to _plotutils.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/spatial/_spherical_voronoi.py to _spherical_voronoi.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/spatial/setup.py to setup.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/_distributor_init.py to _distributor_init.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/fftpack/basic.py to basic.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/fftpack/__init__.py to __init__.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/fftpack/realtransforms.py to realtransforms.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/fftpack/pseudo_diffs.py to pseudo_diffs.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/fftpack/setup.py to setup.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/fftpack/helper.py to helper.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/version.py to version.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/idl.py to idl.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/netcdf.py to netcdf.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/mmio.py to mmio.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/__init__.py to __init__.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/wavfile.py to wavfile.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/_fortran.py to _fortran.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/setup.py to setup.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/harwell_boeing/_fortran_format_parser.py to _fortran_format_parser.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/harwell_boeing/__init__.py to __init__.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/harwell_boeing/setup.py to setup.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/harwell_boeing/hb.py to hb.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/matlab/mio.py to mio.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/matlab/__init__.py to __init__.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/matlab/byteordercodes.py to byteordercodes.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/matlab/mio5.py to mio5.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/matlab/mio5_params.py to mio5_params.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/matlab/mio4.py to mio4.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/matlab/setup.py to setup.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/matlab/miobase.py to miobase.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/arff/__init__.py to __init__.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/arff/setup.py to setup.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/arff/arffread.py to arffread.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/linalg/basic.py to basic.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/linalg/misc.py to misc.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/linalg/_expm_frechet.py to _expm_frechet.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/linalg/linalg_version.py to linalg_version.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/linalg/_decomp_qz.py to _decomp_qz.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/linalg/decomp_schur.py to decomp_schur.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/linalg/_procrustes.py to _procrustes.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/linalg/lapack.py to lapack.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/linalg/decomp_lu.py to decomp_lu.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/linalg/blas.py to blas.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/linalg/matfuncs.py to matfuncs.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/linalg/__init__.py to __init__.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/linalg/_matfuncs_sqrtm.py to _matfuncs_sqrtm.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/linalg/_solvers.py to _solvers.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/linalg/decomp.py to decomp.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/linalg/_testutils.py to _testutils.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/linalg/_decomp_polar.py to _decomp_polar.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/linalg/_cython_signature_generator.py to _cython_signature_generator.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/linalg/special_matrices.py to special_matrices.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/linalg/flinalg.py to flinalg.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/linalg/_matfuncs_inv_ssq.py to _matfuncs_inv_ssq.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/linalg/setup.py to setup.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/linalg/decomp_qr.py to decomp_qr.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/linalg/_sketches.py to _sketches.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/linalg/interpolative.py to interpolative.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/linalg/_generate_pyx.py to _generate_pyx.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/linalg/decomp_cholesky.py to decomp_cholesky.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/linalg/decomp_svd.py to decomp_svd.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/linalg/_interpolative_backend.py to _interpolative_backend.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/cluster/__init__.py to __init__.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/cluster/vq.py to vq.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/cluster/hierarchy.py to hierarchy.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/cluster/setup.py to setup.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/odr/add_newdocs.py to add_newdocs.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/odr/models.py to models.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/odr/__init__.py to __init__.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/odr/odrpack.py to odrpack.pyc byte-compiling /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/odr/setup.py to setup.pyc running install_data creating /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/sparse/linalg/dsolve/tests copying scipy/sparse/linalg/dsolve/tests/test_linsolve.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/sparse/linalg/dsolve/tests/ copying scipy/sparse/linalg/dsolve/tests/__init__.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/sparse/linalg/dsolve/tests/ creating /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/sparse/csgraph/tests copying scipy/sparse/csgraph/tests/test_reordering.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/sparse/csgraph/tests/ copying scipy/sparse/csgraph/tests/test_connected_components.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/sparse/csgraph/tests/ copying scipy/sparse/csgraph/tests/test_conversions.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/sparse/csgraph/tests/ copying scipy/sparse/csgraph/tests/test_graph_laplacian.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/sparse/csgraph/tests/ copying scipy/sparse/csgraph/tests/test_traversal.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/sparse/csgraph/tests/ copying scipy/sparse/csgraph/tests/test_shortest_path.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/sparse/csgraph/tests/ copying scipy/sparse/csgraph/tests/__init__.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/sparse/csgraph/tests/ copying scipy/sparse/csgraph/tests/test_spanning_tree.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/sparse/csgraph/tests/ creating /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/stats/tests creating /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/stats/tests/data creating /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/stats/tests/data/nist_linregress copying scipy/stats/tests/data/nist_linregress/Norris.dat -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/stats/tests/data/nist_linregress copying scipy/special/cython_special.pxd -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/special/ creating /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/sparse/tests copying scipy/sparse/tests/__init__.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/sparse/tests/ copying scipy/sparse/tests/test_construct.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/sparse/tests/ copying scipy/sparse/tests/test_csr.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/sparse/tests/ copying scipy/sparse/tests/test_sputils.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/sparse/tests/ copying scipy/sparse/tests/test_spfuncs.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/sparse/tests/ copying scipy/sparse/tests/test_extract.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/sparse/tests/ copying scipy/sparse/tests/test_matrix_io.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/sparse/tests/ copying scipy/sparse/tests/test_base.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/sparse/tests/ copying scipy/sparse/tests/test_sparsetools.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/sparse/tests/ copying scipy/sparse/tests/test_csc.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/sparse/tests/ creating /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/interpolate/tests copying scipy/interpolate/tests/test_gil.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/interpolate/tests/ copying scipy/interpolate/tests/test_polyint.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/interpolate/tests/ copying scipy/interpolate/tests/test_rbf.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/interpolate/tests/ copying scipy/interpolate/tests/test_interpolate.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/interpolate/tests/ copying scipy/interpolate/tests/test_ndgriddata.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/interpolate/tests/ copying scipy/interpolate/tests/test_pade.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/interpolate/tests/ copying scipy/interpolate/tests/test_fitpack.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/interpolate/tests/ copying scipy/interpolate/tests/test_bsplines.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/interpolate/tests/ copying scipy/interpolate/tests/__init__.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/interpolate/tests/ copying scipy/interpolate/tests/test_fitpack2.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/interpolate/tests/ copying scipy/interpolate/tests/test_regression.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/interpolate/tests/ copying scipy/interpolate/tests/test_interpnd.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/interpolate/tests/ copying scipy/interpolate/tests/test_interpolate_wrapper.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/interpolate/tests/ creating /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/special/tests creating /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/special/tests/data copying scipy/special/tests/data/boost.npz -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/special/tests/data copying scipy/special/tests/data/local.npz -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/special/tests/data copying scipy/special/tests/data/gsl.npz -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/special/tests/data copying scipy/special/tests/data/README -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/special/tests/data copying scipy/stats/tests/test_rank.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/stats/tests/ copying scipy/stats/tests/test_kdeoth.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/stats/tests/ copying scipy/stats/tests/test_morestats.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/stats/tests/ copying scipy/stats/tests/test_fit.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/stats/tests/ copying scipy/stats/tests/test_discrete_distns.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/stats/tests/ copying scipy/stats/tests/test_multivariate.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/stats/tests/ copying scipy/stats/tests/test_distributions.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/stats/tests/ copying scipy/stats/tests/test_binned_statistic.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/stats/tests/ copying scipy/stats/tests/test_contingency.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/stats/tests/ copying scipy/stats/tests/test_discrete_basic.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/stats/tests/ copying scipy/stats/tests/test_mstats_basic.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/stats/tests/ copying scipy/stats/tests/test_continuous_basic.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/stats/tests/ copying scipy/stats/tests/common_tests.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/stats/tests/ copying scipy/stats/tests/__init__.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/stats/tests/ copying scipy/stats/tests/test_tukeylambda_stats.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/stats/tests/ copying scipy/stats/tests/test_mstats_extras.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/stats/tests/ copying scipy/stats/tests/test_stats.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/stats/tests/ creating /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/spatial/qhull copying scipy/spatial/qhull/COPYING.txt -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/spatial/qhull creating /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/sparse/linalg/eigen/arpack/tests copying scipy/sparse/linalg/eigen/arpack/tests/test_arpack.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/sparse/linalg/eigen/arpack/tests/ copying scipy/sparse/linalg/eigen/arpack/tests/__init__.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/sparse/linalg/eigen/arpack/tests/ copying scipy/linalg/cython_lapack.pxd -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/linalg/ copying scipy/linalg/cython_blas.pxd -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/linalg/ creating /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/stats/tests/data/nist_anova copying scipy/stats/tests/data/nist_anova/AtmWtAg.dat -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/stats/tests/data/nist_anova copying scipy/stats/tests/data/nist_anova/SmLs09.dat -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/stats/tests/data/nist_anova copying scipy/stats/tests/data/nist_anova/SiRstv.dat -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/stats/tests/data/nist_anova copying scipy/stats/tests/data/nist_anova/SmLs02.dat -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/stats/tests/data/nist_anova copying scipy/stats/tests/data/nist_anova/SmLs03.dat -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/stats/tests/data/nist_anova copying scipy/stats/tests/data/nist_anova/SmLs05.dat -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/stats/tests/data/nist_anova copying scipy/stats/tests/data/nist_anova/SmLs07.dat -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/stats/tests/data/nist_anova copying scipy/stats/tests/data/nist_anova/SmLs04.dat -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/stats/tests/data/nist_anova copying scipy/stats/tests/data/nist_anova/SmLs06.dat -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/stats/tests/data/nist_anova copying scipy/stats/tests/data/nist_anova/SmLs01.dat -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/stats/tests/data/nist_anova copying scipy/stats/tests/data/nist_anova/SmLs08.dat -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/stats/tests/data/nist_anova creating /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/sparse/linalg/isolve/tests copying scipy/sparse/linalg/isolve/tests/demo_lgmres.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/sparse/linalg/isolve/tests/ copying scipy/sparse/linalg/isolve/tests/test_gcrotmk.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/sparse/linalg/isolve/tests/ copying scipy/sparse/linalg/isolve/tests/test_utils.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/sparse/linalg/isolve/tests/ copying scipy/sparse/linalg/isolve/tests/test_iterative.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/sparse/linalg/isolve/tests/ copying scipy/sparse/linalg/isolve/tests/__init__.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/sparse/linalg/isolve/tests/ copying scipy/sparse/linalg/isolve/tests/test_lgmres.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/sparse/linalg/isolve/tests/ copying scipy/sparse/linalg/isolve/tests/test_lsmr.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/sparse/linalg/isolve/tests/ copying scipy/sparse/linalg/isolve/tests/test_lsqr.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/sparse/linalg/isolve/tests/ creating /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/optimize/lbfgsb copying scipy/optimize/lbfgsb/README -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/optimize/lbfgsb creating /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/odr/tests copying scipy/odr/tests/test_odr.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/odr/tests/ copying scipy/odr/tests/__init__.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/odr/tests/ creating /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/cluster/tests copying scipy/cluster/tests/test_hierarchy.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/cluster/tests/ copying scipy/cluster/tests/hierarchy_test_data.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/cluster/tests/ copying scipy/cluster/tests/test_vq.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/cluster/tests/ copying scipy/cluster/tests/__init__.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/cluster/tests/ creating /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/integrate/tests copying scipy/integrate/tests/test_quadpack.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/integrate/tests/ copying scipy/integrate/tests/test_odeint_jac.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/integrate/tests/ copying scipy/integrate/tests/test_bvp.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/integrate/tests/ copying scipy/integrate/tests/test_ivp.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/integrate/tests/ copying scipy/integrate/tests/_test_multivariate.c -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/integrate/tests/ copying scipy/integrate/tests/test_integrate.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/integrate/tests/ copying scipy/integrate/tests/test_quadrature.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/integrate/tests/ copying scipy/integrate/tests/banded5x5.f -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/integrate/tests/ copying scipy/integrate/tests/test_banded_ode_solvers.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/integrate/tests/ copying scipy/integrate/tests/__init__.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/integrate/tests/ creating /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/interpolate/tests/data copying scipy/interpolate/tests/data/estimate_gradients_hang.npy -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/interpolate/tests/data copying scipy/interpolate/tests/data/bug-1310.npz -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/interpolate/tests/data creating /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/spatial/tests copying scipy/spatial/tests/test__procrustes.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/spatial/tests/ copying scipy/spatial/tests/test_spherical_voronoi.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/spatial/tests/ copying scipy/spatial/tests/test_qhull.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/spatial/tests/ copying scipy/spatial/tests/test_kdtree.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/spatial/tests/ copying scipy/spatial/tests/test_hausdorff.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/spatial/tests/ copying scipy/spatial/tests/test__plotutils.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/spatial/tests/ copying scipy/spatial/tests/__init__.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/spatial/tests/ copying scipy/spatial/tests/test_distance.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/spatial/tests/ creating /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/linalg/src creating /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/linalg/src/lapack_deprecations copying scipy/linalg/src/lapack_deprecations/LICENSE -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/linalg/src/lapack_deprecations creating /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/optimize/tests copying scipy/optimize/tests/test_zeros.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/optimize/tests/ copying scipy/optimize/tests/test__root.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/optimize/tests/ copying scipy/optimize/tests/test_trustregion_exact.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/optimize/tests/ copying scipy/optimize/tests/test_nnls.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/optimize/tests/ copying scipy/optimize/tests/test_minpack.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/optimize/tests/ copying scipy/optimize/tests/test_cobyla.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/optimize/tests/ copying scipy/optimize/tests/__init__.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/optimize/tests/ copying scipy/optimize/tests/test_lbfgsb_hessinv.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/optimize/tests/ copying scipy/optimize/tests/test_trustregion.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/optimize/tests/ copying scipy/optimize/tests/test__differential_evolution.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/optimize/tests/ copying scipy/optimize/tests/test_lsq_common.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/optimize/tests/ copying scipy/optimize/tests/test__spectral.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/optimize/tests/ copying scipy/optimize/tests/test_regression.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/optimize/tests/ copying scipy/optimize/tests/test_lsq_linear.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/optimize/tests/ copying scipy/optimize/tests/test_linprog.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/optimize/tests/ copying scipy/optimize/tests/test_nonlin.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/optimize/tests/ copying scipy/optimize/tests/test__numdiff.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/optimize/tests/ copying scipy/optimize/tests/test__basinhopping.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/optimize/tests/ copying scipy/optimize/tests/test_trustregion_krylov.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/optimize/tests/ copying scipy/optimize/tests/test_hungarian.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/optimize/tests/ copying scipy/optimize/tests/test_tnc.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/optimize/tests/ copying scipy/optimize/tests/test__remove_redundancy.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/optimize/tests/ copying scipy/optimize/tests/test_linesearch.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/optimize/tests/ copying scipy/optimize/tests/test_least_squares.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/optimize/tests/ copying scipy/optimize/tests/test__linprog_ip_clean_inputs.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/optimize/tests/ copying scipy/optimize/tests/test_optimize.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/optimize/tests/ copying scipy/optimize/tests/test_slsqp.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/optimize/tests/ creating /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/signal/tests copying scipy/signal/tests/test_peak_finding.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/signal/tests/ copying scipy/signal/tests/test_signaltools.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/signal/tests/ copying scipy/signal/tests/test_ltisys.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/signal/tests/ copying scipy/signal/tests/test_dltisys.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/signal/tests/ copying scipy/signal/tests/test_savitzky_golay.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/signal/tests/ copying scipy/signal/tests/test_fir_filter_design.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/signal/tests/ copying scipy/signal/tests/test_spectral.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/signal/tests/ copying scipy/signal/tests/mpsig.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/signal/tests/ copying scipy/signal/tests/test_max_len_seq.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/signal/tests/ copying scipy/signal/tests/test_wavelets.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/signal/tests/ copying scipy/signal/tests/test_array_tools.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/signal/tests/ copying scipy/signal/tests/test_waveforms.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/signal/tests/ copying scipy/signal/tests/__init__.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/signal/tests/ copying scipy/signal/tests/test_windows.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/signal/tests/ copying scipy/signal/tests/test_filter_design.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/signal/tests/ copying scipy/signal/tests/test_upfirdn.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/signal/tests/ copying scipy/signal/tests/test_cont2discrete.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/signal/tests/ creating /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/matlab/tests copying scipy/io/matlab/tests/__init__.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/matlab/tests/ copying scipy/io/matlab/tests/test_mio_utils.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/matlab/tests/ copying scipy/io/matlab/tests/gen_mat5files.m -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/matlab/tests/ copying scipy/io/matlab/tests/test_streams.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/matlab/tests/ copying scipy/io/matlab/tests/test_byteordercodes.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/matlab/tests/ copying scipy/io/matlab/tests/test_mio_funcs.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/matlab/tests/ copying scipy/io/matlab/tests/test_miobase.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/matlab/tests/ copying scipy/io/matlab/tests/gen_mat4files.m -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/matlab/tests/ copying scipy/io/matlab/tests/test_pathological.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/matlab/tests/ copying scipy/io/matlab/tests/afunc.m -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/matlab/tests/ copying scipy/io/matlab/tests/save_matfile.m -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/matlab/tests/ copying scipy/io/matlab/tests/test_mio.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/matlab/tests/ copying scipy/io/matlab/tests/test_mio5_utils.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/matlab/tests/ copying scipy/special/tests/test_precompute_gammainc.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/special/tests copying scipy/special/tests/test_orthogonal_eval.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/special/tests copying scipy/special/tests/test_cython_special.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/special/tests copying scipy/special/tests/test_kolmogorov.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/special/tests copying scipy/special/tests/test_sf_error.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/special/tests copying scipy/special/tests/test_orthogonal.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/special/tests copying scipy/special/tests/test_pcf.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/special/tests copying scipy/special/tests/test_digamma.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/special/tests copying scipy/special/tests/test_spence.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/special/tests copying scipy/special/tests/test_trig.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/special/tests copying scipy/special/tests/test_cdflib.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/special/tests copying scipy/special/tests/test_wrightomega.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/special/tests copying scipy/special/tests/test_precompute_expn_asy.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/special/tests copying scipy/special/tests/test_spherical_bessel.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/special/tests copying scipy/special/tests/test_gammainc.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/special/tests copying scipy/special/tests/test_precompute_utils.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/special/tests copying scipy/special/tests/test_round.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/special/tests copying scipy/special/tests/test_boxcox.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/special/tests copying scipy/special/tests/__init__.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/special/tests copying scipy/special/tests/test_lambertw.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/special/tests copying scipy/special/tests/test_loggamma.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/special/tests copying scipy/special/tests/test_spfun_stats.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/special/tests copying scipy/special/tests/test_sici.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/special/tests copying scipy/special/tests/test_basic.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/special/tests copying scipy/special/tests/test_logsumexp.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/special/tests copying scipy/special/tests/test_mpmath.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/special/tests copying scipy/special/tests/test_ellip_harm.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/special/tests copying scipy/special/tests/test_logit.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/special/tests copying scipy/special/tests/test_sph_harm.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/special/tests copying scipy/special/tests/test_data.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/special/tests creating /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/misc/tests creating /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/misc/tests/data copying scipy/misc/tests/data/5x5x4.png -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/misc/tests/data copying scipy/misc/tests/data/4x5x3.png -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/misc/tests/data copying scipy/misc/tests/data/5x4x4.png -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/misc/tests/data copying scipy/misc/tests/data/4x4x4.png -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/misc/tests/data copying scipy/misc/tests/data/icon_mono_flat.png -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/misc/tests/data copying scipy/misc/tests/data/box1.png -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/misc/tests/data copying scipy/misc/tests/data/3x3x4.png -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/misc/tests/data copying scipy/misc/tests/data/blocks2bit.png -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/misc/tests/data copying scipy/misc/tests/data/4x3x3.png -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/misc/tests/data copying scipy/misc/tests/data/4x3x4.png -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/misc/tests/data copying scipy/misc/tests/data/5x3x4.png -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/misc/tests/data copying scipy/misc/tests/data/3x4x3.png -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/misc/tests/data copying scipy/misc/tests/data/4x4x3.png -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/misc/tests/data copying scipy/misc/tests/data/5x5x3.png -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/misc/tests/data copying scipy/misc/tests/data/5x3x3.png -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/misc/tests/data copying scipy/misc/tests/data/3x5x4.png -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/misc/tests/data copying scipy/misc/tests/data/3x4x4.png -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/misc/tests/data copying scipy/misc/tests/data/pattern4bit.png -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/misc/tests/data copying scipy/misc/tests/data/4x5x4.png -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/misc/tests/data copying scipy/misc/tests/data/3x3x3.png -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/misc/tests/data copying scipy/misc/tests/data/icon.png -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/misc/tests/data copying scipy/misc/tests/data/foo3x5x4indexed.png -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/misc/tests/data copying scipy/misc/tests/data/5x4x3.png -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/misc/tests/data copying scipy/misc/tests/data/icon_mono.png -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/misc/tests/data copying scipy/misc/tests/data/3x5x3.png -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/misc/tests/data creating /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/arff/tests creating /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/arff/tests/data copying scipy/io/arff/tests/data/test3.arff -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/arff/tests/data copying scipy/io/arff/tests/data/test8.arff -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/arff/tests/data copying scipy/io/arff/tests/data/test7.arff -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/arff/tests/data copying scipy/io/arff/tests/data/test1.arff -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/arff/tests/data copying scipy/io/arff/tests/data/nodata.arff -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/arff/tests/data copying scipy/io/arff/tests/data/test4.arff -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/arff/tests/data copying scipy/io/arff/tests/data/test5.arff -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/arff/tests/data copying scipy/io/arff/tests/data/iris.arff -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/arff/tests/data copying scipy/io/arff/tests/data/test6.arff -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/arff/tests/data copying scipy/io/arff/tests/data/missing.arff -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/arff/tests/data copying scipy/io/arff/tests/data/test2.arff -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/arff/tests/data creating /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/sparse/linalg/eigen/arpack/ARPACK copying scipy/sparse/linalg/eigen/arpack/ARPACK/COPYING -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/sparse/linalg/eigen/arpack/ARPACK creating /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/sparse/linalg/eigen/lobpcg/tests copying scipy/sparse/linalg/eigen/lobpcg/tests/test_lobpcg.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/sparse/linalg/eigen/lobpcg/tests/ copying scipy/sparse/linalg/eigen/lobpcg/tests/__init__.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/sparse/linalg/eigen/lobpcg/tests/ creating /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/linalg/tests copying scipy/linalg/tests/test_sketches.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/linalg/tests/ copying scipy/linalg/tests/test_solve_toeplitz.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/linalg/tests/ copying scipy/linalg/tests/test_fblas.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/linalg/tests/ copying scipy/linalg/tests/__init__.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/linalg/tests/ copying scipy/linalg/tests/test_decomp.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/linalg/tests/ copying scipy/linalg/tests/test_decomp_polar.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/linalg/tests/ copying scipy/linalg/tests/test_interpolative.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/linalg/tests/ copying scipy/linalg/tests/test_cython_blas.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/linalg/tests/ copying scipy/linalg/tests/test_procrustes.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/linalg/tests/ copying scipy/linalg/tests/test_build.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/linalg/tests/ copying scipy/linalg/tests/test_decomp_cholesky.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/linalg/tests/ copying scipy/linalg/tests/test_basic.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/linalg/tests/ copying scipy/linalg/tests/test_lapack.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/linalg/tests/ copying scipy/linalg/tests/test_decomp_update.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/linalg/tests/ copying scipy/linalg/tests/test_special_matrices.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/linalg/tests/ copying scipy/linalg/tests/test_solvers.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/linalg/tests/ copying scipy/linalg/tests/test_cython_lapack.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/linalg/tests/ copying scipy/linalg/tests/test_matfuncs.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/linalg/tests/ copying scipy/linalg/tests/test_blas.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/linalg/tests/ creating /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/_lib/tests copying scipy/_lib/tests/test__util.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/_lib/tests copying scipy/_lib/tests/test__gcutils.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/_lib/tests copying scipy/_lib/tests/test__testutils.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/_lib/tests copying scipy/_lib/tests/test_tmpdirs.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/_lib/tests copying scipy/_lib/tests/test_warnings.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/_lib/tests copying scipy/_lib/tests/test_ccallback.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/_lib/tests copying scipy/_lib/tests/test__threadsafety.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/_lib/tests copying scipy/_lib/tests/test__version.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/_lib/tests copying scipy/_lib/tests/__init__.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/_lib/tests creating /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/sparse/linalg/tests copying scipy/sparse/linalg/tests/test_expm_multiply.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/sparse/linalg/tests/ copying scipy/sparse/linalg/tests/test_norm.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/sparse/linalg/tests/ copying scipy/sparse/linalg/tests/test_matfuncs.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/sparse/linalg/tests/ copying scipy/sparse/linalg/tests/__init__.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/sparse/linalg/tests/ copying scipy/sparse/linalg/tests/test_interface.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/sparse/linalg/tests/ copying scipy/sparse/linalg/tests/test_onenormest.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/sparse/linalg/tests/ copying HACKING.rst.txt -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy copying LICENSE.txt -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy copying BENTO_BUILD.txt -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy copying INSTALL.rst.txt -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy copying THANKS.txt -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy creating /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/linalg/src/id_dist creating /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/linalg/src/id_dist/doc copying scipy/linalg/src/id_dist/doc/doc.tex -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/linalg/src/id_dist/doc copying scipy/special.pxd -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/ copying scipy/linalg.pxd -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/ creating /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/ndimage/tests copying scipy/ndimage/tests/dots.png -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/ndimage/tests/ copying scipy/ndimage/tests/__init__.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/ndimage/tests/ copying scipy/ndimage/tests/test_filters.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/ndimage/tests/ copying scipy/ndimage/tests/test_c_api.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/ndimage/tests/ copying scipy/ndimage/tests/test_measurements.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/ndimage/tests/ copying scipy/ndimage/tests/test_ndimage.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/ndimage/tests/ copying scipy/ndimage/tests/test_io.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/ndimage/tests/ copying scipy/ndimage/tests/test_datatypes.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/ndimage/tests/ copying scipy/ndimage/tests/test_regression.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/ndimage/tests/ copying scipy/misc/tests/__init__.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/misc/tests/ copying scipy/misc/tests/test_pilutil.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/misc/tests/ copying scipy/misc/tests/test_common.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/misc/tests/ copying scipy/misc/tests/test_doccer.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/misc/tests/ creating /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/sparse/tests/data copying scipy/sparse/tests/data/csc_py2.npz -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/sparse/tests/data copying scipy/sparse/tests/data/csc_py3.npz -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/sparse/tests/data copying scipy/io/arff/tests/__init__.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/arff/tests/ copying scipy/io/arff/tests/test_arffread.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/arff/tests/ creating /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/sparse/linalg/dsolve/SuperLU copying scipy/sparse/linalg/dsolve/SuperLU/License.txt -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/sparse/linalg/dsolve/SuperLU creating /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/matlab/tests/data copying scipy/io/matlab/tests/data/testcell_7.4_GLNX86.mat -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/matlab/tests/data copying scipy/io/matlab/tests/data/teststring_7.1_GLNX86.mat -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/matlab/tests/data copying scipy/io/matlab/tests/data/teststringarray_7.1_GLNX86.mat -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/matlab/tests/data copying scipy/io/matlab/tests/data/test3dmatrix_7.1_GLNX86.mat -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/matlab/tests/data copying scipy/io/matlab/tests/data/testminus_6.1_SOL2.mat -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/matlab/tests/data copying scipy/io/matlab/tests/data/testbool_8_WIN64.mat -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/matlab/tests/data copying scipy/io/matlab/tests/data/testunicode_7.1_GLNX86.mat -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/matlab/tests/data copying scipy/io/matlab/tests/data/test3dmatrix_7.4_GLNX86.mat -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/matlab/tests/data copying scipy/io/matlab/tests/data/testemptycell_6.5.1_GLNX86.mat -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/matlab/tests/data copying scipy/io/matlab/tests/data/teststructarr_7.1_GLNX86.mat -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/matlab/tests/data copying scipy/io/matlab/tests/data/test_skip_variable.mat -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/matlab/tests/data copying scipy/io/matlab/tests/data/testmatrix_4.2c_SOL2.mat -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/matlab/tests/data copying scipy/io/matlab/tests/data/testonechar_4.2c_SOL2.mat -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/matlab/tests/data copying scipy/io/matlab/tests/data/teststructarr_6.1_SOL2.mat -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/matlab/tests/data copying scipy/io/matlab/tests/data/miuint32_for_miint32.mat -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/matlab/tests/data copying scipy/io/matlab/tests/data/teststring_6.5.1_GLNX86.mat -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/matlab/tests/data copying scipy/io/matlab/tests/data/corrupted_zlib_checksum.mat -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/matlab/tests/data copying scipy/io/matlab/tests/data/teststruct_6.1_SOL2.mat -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/matlab/tests/data copying scipy/io/matlab/tests/data/testmatrix_6.5.1_GLNX86.mat -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/matlab/tests/data copying scipy/io/matlab/tests/data/miutf8_array_name.mat -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/matlab/tests/data copying scipy/io/matlab/tests/data/testdouble_7.1_GLNX86.mat -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/matlab/tests/data copying scipy/io/matlab/tests/data/test3dmatrix_6.1_SOL2.mat -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/matlab/tests/data copying scipy/io/matlab/tests/data/teststring_6.1_SOL2.mat -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/matlab/tests/data copying scipy/io/matlab/tests/data/testobject_6.1_SOL2.mat -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/matlab/tests/data copying scipy/io/matlab/tests/data/testsparsecomplex_4.2c_SOL2.mat -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/matlab/tests/data copying scipy/io/matlab/tests/data/testonechar_7.4_GLNX86.mat -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/matlab/tests/data copying scipy/io/matlab/tests/data/testsparsecomplex_6.1_SOL2.mat -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/matlab/tests/data copying scipy/io/matlab/tests/data/testsparse_6.1_SOL2.mat -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/matlab/tests/data copying scipy/io/matlab/tests/data/testcomplex_7.1_GLNX86.mat -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/matlab/tests/data copying scipy/io/matlab/tests/data/bad_miutf8_array_name.mat -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/matlab/tests/data copying scipy/io/matlab/tests/data/single_empty_string.mat -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/matlab/tests/data copying scipy/io/matlab/tests/data/teststringarray_4.2c_SOL2.mat -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/matlab/tests/data copying scipy/io/matlab/tests/data/testcomplex_6.1_SOL2.mat -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/matlab/tests/data copying scipy/io/matlab/tests/data/testmulti_7.1_GLNX86.mat -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/matlab/tests/data copying scipy/io/matlab/tests/data/teststructnest_7.4_GLNX86.mat -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/matlab/tests/data copying scipy/io/matlab/tests/data/japanese_utf8.txt -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/matlab/tests/data copying scipy/io/matlab/tests/data/big_endian.mat -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/matlab/tests/data copying scipy/io/matlab/tests/data/teststringarray_6.1_SOL2.mat -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/matlab/tests/data copying scipy/io/matlab/tests/data/testsparse_7.1_GLNX86.mat -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/matlab/tests/data copying scipy/io/matlab/tests/data/testmulti_4.2c_SOL2.mat -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/matlab/tests/data copying scipy/io/matlab/tests/data/testsparse_4.2c_SOL2.mat -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/matlab/tests/data copying scipy/io/matlab/tests/data/testonechar_6.5.1_GLNX86.mat -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/matlab/tests/data copying scipy/io/matlab/tests/data/logical_sparse.mat -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/matlab/tests/data copying scipy/io/matlab/tests/data/testonechar_6.1_SOL2.mat -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/matlab/tests/data copying scipy/io/matlab/tests/data/testmatrix_7.1_GLNX86.mat -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/matlab/tests/data copying scipy/io/matlab/tests/data/testsparse_6.5.1_GLNX86.mat -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/matlab/tests/data copying scipy/io/matlab/tests/data/nasty_duplicate_fieldnames.mat -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/matlab/tests/data copying scipy/io/matlab/tests/data/sqr.mat -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/matlab/tests/data copying scipy/io/matlab/tests/data/testcomplex_6.5.1_GLNX86.mat -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/matlab/tests/data copying scipy/io/matlab/tests/data/testvec_4_GLNX86.mat -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/matlab/tests/data copying scipy/io/matlab/tests/data/testcellnest_7.4_GLNX86.mat -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/matlab/tests/data copying scipy/io/matlab/tests/data/malformed1.mat -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/matlab/tests/data copying scipy/io/matlab/tests/data/testcomplex_4.2c_SOL2.mat -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/matlab/tests/data copying scipy/io/matlab/tests/data/testemptycell_5.3_SOL2.mat -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/matlab/tests/data copying scipy/io/matlab/tests/data/testfunc_7.4_GLNX86.mat -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/matlab/tests/data copying scipy/io/matlab/tests/data/teststructnest_6.1_SOL2.mat -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/matlab/tests/data copying scipy/io/matlab/tests/data/testmatrix_6.1_SOL2.mat -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/matlab/tests/data copying scipy/io/matlab/tests/data/testsparsefloat_7.4_GLNX86.mat -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/matlab/tests/data copying scipy/io/matlab/tests/data/testdouble_6.5.1_GLNX86.mat -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/matlab/tests/data copying scipy/io/matlab/tests/data/testmulti_7.4_GLNX86.mat -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/matlab/tests/data copying scipy/io/matlab/tests/data/bad_miuint32.mat -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/matlab/tests/data copying scipy/io/matlab/tests/data/testminus_7.1_GLNX86.mat -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/matlab/tests/data copying scipy/io/matlab/tests/data/testsparsecomplex_7.4_GLNX86.mat -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/matlab/tests/data copying scipy/io/matlab/tests/data/testcellnest_7.1_GLNX86.mat -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/matlab/tests/data copying scipy/io/matlab/tests/data/little_endian.mat -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/matlab/tests/data copying scipy/io/matlab/tests/data/teststruct_6.5.1_GLNX86.mat -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/matlab/tests/data copying scipy/io/matlab/tests/data/testminus_7.4_GLNX86.mat -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/matlab/tests/data copying scipy/io/matlab/tests/data/testemptycell_7.4_GLNX86.mat -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/matlab/tests/data copying scipy/io/matlab/tests/data/teststring_4.2c_SOL2.mat -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/matlab/tests/data copying scipy/io/matlab/tests/data/testunicode_7.4_GLNX86.mat -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/matlab/tests/data copying scipy/io/matlab/tests/data/some_functions.mat -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/matlab/tests/data copying scipy/io/matlab/tests/data/testcell_6.5.1_GLNX86.mat -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/matlab/tests/data copying scipy/io/matlab/tests/data/testdouble_4.2c_SOL2.mat -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/matlab/tests/data copying scipy/io/matlab/tests/data/teststruct_7.1_GLNX86.mat -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/matlab/tests/data copying scipy/io/matlab/tests/data/testscalarcell_7.4_GLNX86.mat -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/matlab/tests/data copying scipy/io/matlab/tests/data/testcell_7.1_GLNX86.mat -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/matlab/tests/data copying scipy/io/matlab/tests/data/teststring_7.4_GLNX86.mat -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/matlab/tests/data copying scipy/io/matlab/tests/data/parabola.mat -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/matlab/tests/data copying scipy/io/matlab/tests/data/teststructnest_6.5.1_GLNX86.mat -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/matlab/tests/data copying scipy/io/matlab/tests/data/testcellnest_6.1_SOL2.mat -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/matlab/tests/data copying scipy/io/matlab/tests/data/testdouble_6.1_SOL2.mat -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/matlab/tests/data copying scipy/io/matlab/tests/data/testdouble_7.4_GLNX86.mat -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/matlab/tests/data copying scipy/io/matlab/tests/data/testemptycell_7.1_GLNX86.mat -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/matlab/tests/data copying scipy/io/matlab/tests/data/testsparsecomplex_6.5.1_GLNX86.mat -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/matlab/tests/data copying scipy/io/matlab/tests/data/testcell_6.1_SOL2.mat -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/matlab/tests/data copying scipy/io/matlab/tests/data/teststructarr_6.5.1_GLNX86.mat -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/matlab/tests/data copying scipy/io/matlab/tests/data/broken_utf8.mat -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/matlab/tests/data copying scipy/io/matlab/tests/data/testcomplex_7.4_GLNX86.mat -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/matlab/tests/data copying scipy/io/matlab/tests/data/testsparsecomplex_7.1_GLNX86.mat -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/matlab/tests/data copying scipy/io/matlab/tests/data/testminus_6.5.1_GLNX86.mat -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/matlab/tests/data copying scipy/io/matlab/tests/data/teststringarray_6.5.1_GLNX86.mat -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/matlab/tests/data copying scipy/io/matlab/tests/data/teststructarr_7.4_GLNX86.mat -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/matlab/tests/data copying scipy/io/matlab/tests/data/testobject_6.5.1_GLNX86.mat -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/matlab/tests/data copying scipy/io/matlab/tests/data/teststructnest_7.1_GLNX86.mat -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/matlab/tests/data copying scipy/io/matlab/tests/data/test_mat4_le_floats.mat -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/matlab/tests/data copying scipy/io/matlab/tests/data/testobject_7.4_GLNX86.mat -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/matlab/tests/data copying scipy/io/matlab/tests/data/testmatrix_7.4_GLNX86.mat -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/matlab/tests/data copying scipy/io/matlab/tests/data/testsparse_7.4_GLNX86.mat -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/matlab/tests/data copying scipy/io/matlab/tests/data/testhdf5_7.4_GLNX86.mat -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/matlab/tests/data copying scipy/io/matlab/tests/data/corrupted_zlib_data.mat -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/matlab/tests/data copying scipy/io/matlab/tests/data/testcellnest_6.5.1_GLNX86.mat -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/matlab/tests/data copying scipy/io/matlab/tests/data/test3dmatrix_6.5.1_GLNX86.mat -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/matlab/tests/data copying scipy/io/matlab/tests/data/teststringarray_7.4_GLNX86.mat -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/matlab/tests/data copying scipy/io/matlab/tests/data/testonechar_7.1_GLNX86.mat -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/matlab/tests/data copying scipy/io/matlab/tests/data/one_by_zero_char.mat -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/matlab/tests/data copying scipy/io/matlab/tests/data/testobject_7.1_GLNX86.mat -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/matlab/tests/data copying scipy/io/matlab/tests/data/testminus_4.2c_SOL2.mat -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/matlab/tests/data copying scipy/io/matlab/tests/data/teststruct_7.4_GLNX86.mat -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/matlab/tests/data copying scipy/io/matlab/tests/data/test_empty_struct.mat -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/matlab/tests/data creating /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/spatial/tests/data copying scipy/spatial/tests/data/pdist-cosine-ml.txt -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/spatial/tests/data copying scipy/spatial/tests/data/pdist-minkowski-5.8-ml-iris.txt -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/spatial/tests/data copying scipy/spatial/tests/data/pdist-minkowski-3.2-ml.txt -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/spatial/tests/data copying scipy/spatial/tests/data/iris.txt -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/spatial/tests/data copying scipy/spatial/tests/data/pdist-spearman-ml.txt -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/spatial/tests/data copying scipy/spatial/tests/data/degenerate_pointset.npz -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/spatial/tests/data copying scipy/spatial/tests/data/pdist-hamming-ml.txt -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/spatial/tests/data copying scipy/spatial/tests/data/pdist-chebyshev-ml.txt -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/spatial/tests/data copying scipy/spatial/tests/data/pdist-correlation-ml-iris.txt -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/spatial/tests/data copying scipy/spatial/tests/data/pdist-double-inp.txt -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/spatial/tests/data copying scipy/spatial/tests/data/pdist-seuclidean-ml.txt -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/spatial/tests/data copying scipy/spatial/tests/data/pdist-chebyshev-ml-iris.txt -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/spatial/tests/data copying scipy/spatial/tests/data/cdist-X1.txt -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/spatial/tests/data copying scipy/spatial/tests/data/random-bool-data.txt -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/spatial/tests/data copying scipy/spatial/tests/data/random-int-data.txt -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/spatial/tests/data copying scipy/spatial/tests/data/pdist-seuclidean-ml-iris.txt -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/spatial/tests/data copying scipy/spatial/tests/data/random-uint-data.txt -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/spatial/tests/data copying scipy/spatial/tests/data/pdist-jaccard-ml.txt -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/spatial/tests/data copying scipy/spatial/tests/data/random-double-data.txt -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/spatial/tests/data copying scipy/spatial/tests/data/pdist-cityblock-ml-iris.txt -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/spatial/tests/data copying scipy/spatial/tests/data/pdist-cosine-ml-iris.txt -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/spatial/tests/data copying scipy/spatial/tests/data/pdist-minkowski-3.2-ml-iris.txt -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/spatial/tests/data copying scipy/spatial/tests/data/pdist-euclidean-ml-iris.txt -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/spatial/tests/data copying scipy/spatial/tests/data/pdist-correlation-ml.txt -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/spatial/tests/data copying scipy/spatial/tests/data/pdist-cityblock-ml.txt -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/spatial/tests/data copying scipy/spatial/tests/data/pdist-boolean-inp.txt -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/spatial/tests/data copying scipy/spatial/tests/data/pdist-euclidean-ml.txt -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/spatial/tests/data copying scipy/spatial/tests/data/selfdual-4d-polytope.txt -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/spatial/tests/data copying scipy/spatial/tests/data/cdist-X2.txt -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/spatial/tests/data creating /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/linalg/tests/data copying scipy/linalg/tests/data/carex_18_data.npz -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/linalg/tests/data copying scipy/linalg/tests/data/carex_6_data.npz -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/linalg/tests/data copying scipy/linalg/tests/data/carex_19_data.npz -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/linalg/tests/data copying scipy/linalg/tests/data/carex_15_data.npz -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/linalg/tests/data copying scipy/linalg/tests/data/carex_20_data.npz -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/linalg/tests/data copying scipy/linalg/tests/data/gendare_20170120_data.npz -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/linalg/tests/data creating /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/ndimage/tests/data copying scipy/ndimage/tests/data/label_inputs.txt -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/ndimage/tests/data copying scipy/ndimage/tests/data/label_strels.txt -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/ndimage/tests/data copying scipy/ndimage/tests/data/README.txt -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/ndimage/tests/data copying scipy/ndimage/tests/data/label_results.txt -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/ndimage/tests/data creating /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/harwell_boeing/tests copying scipy/io/harwell_boeing/tests/test_fortran_format.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/harwell_boeing/tests/ copying scipy/io/harwell_boeing/tests/__init__.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/harwell_boeing/tests/ copying scipy/io/harwell_boeing/tests/test_hb.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/harwell_boeing/tests/ copying scipy/misc/ascent.dat -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/misc/ copying scipy/misc/face.dat -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/misc/ creating /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/constants/tests copying scipy/constants/tests/test_constants.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/constants/tests/ copying scipy/constants/tests/test_codata.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/constants/tests/ copying scipy/constants/tests/__init__.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/constants/tests/ creating /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/tests copying scipy/io/tests/test_fortran.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/tests/ copying scipy/io/tests/test_idl.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/tests/ copying scipy/io/tests/test_wavfile.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/tests/ copying scipy/io/tests/__init__.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/tests/ copying scipy/io/tests/test_mmio.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/tests/ copying scipy/io/tests/test_paths.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/tests/ copying scipy/io/tests/test_netcdf.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/tests/ creating /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/tests/data copying scipy/io/tests/data/scalar_complex64.sav -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/tests/data copying scipy/io/tests/data/fortran-si4-15x10x22.dat -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/tests/data copying scipy/io/tests/data/struct_pointers_replicated_3d.sav -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/tests/data copying scipy/io/tests/data/test-44100Hz-2ch-32bit-float-be.wav -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/tests/data copying scipy/io/tests/data/scalar_string.sav -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/tests/data copying scipy/io/tests/data/struct_pointers_replicated.sav -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/tests/data copying scipy/io/tests/data/fortran-si4-1x1x1.dat -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/tests/data copying scipy/io/tests/data/example_3_maskedvals.nc -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/tests/data copying scipy/io/tests/data/scalar_byte.sav -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/tests/data copying scipy/io/tests/data/array_float32_4d.sav -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/tests/data copying scipy/io/tests/data/struct_scalars.sav -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/tests/data copying scipy/io/tests/data/test-44100Hz-le-1ch-4bytes-incomplete-chunk.wav -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/tests/data copying scipy/io/tests/data/scalar_float32.sav -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/tests/data copying scipy/io/tests/data/struct_pointer_arrays.sav -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/tests/data copying scipy/io/tests/data/test-44100Hz-2ch-32bit-float-le.wav -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/tests/data copying scipy/io/tests/data/fortran-si4-1x1x7.dat -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/tests/data copying scipy/io/tests/data/array_float32_2d.sav -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/tests/data copying scipy/io/tests/data/fortran-3x3d-2i.dat -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/tests/data copying scipy/io/tests/data/array_float32_pointer_6d.sav -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/tests/data copying scipy/io/tests/data/example_1.nc -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/tests/data copying scipy/io/tests/data/various_compressed.sav -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/tests/data copying scipy/io/tests/data/array_float32_pointer_2d.sav -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/tests/data copying scipy/io/tests/data/struct_pointers.sav -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/tests/data copying scipy/io/tests/data/test-48000Hz-2ch-64bit-float-le-wavex.wav -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/tests/data copying scipy/io/tests/data/scalar_float64.sav -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/tests/data copying scipy/io/tests/data/scalar_uint64.sav -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/tests/data copying scipy/io/tests/data/struct_scalars_replicated.sav -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/tests/data copying scipy/io/tests/data/invalid_pointer.sav -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/tests/data copying scipy/io/tests/data/struct_pointer_arrays_replicated_3d.sav -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/tests/data copying scipy/io/tests/data/fortran-si4-11x1x10.dat -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/tests/data copying scipy/io/tests/data/array_float32_pointer_1d.sav -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/tests/data copying scipy/io/tests/data/array_float32_pointer_4d.sav -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/tests/data copying scipy/io/tests/data/struct_arrays.sav -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/tests/data copying scipy/io/tests/data/array_float32_8d.sav -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/tests/data copying scipy/io/tests/data/struct_arrays_byte_idl80.sav -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/tests/data copying scipy/io/tests/data/fortran-sf8-1x1x5.dat -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/tests/data copying scipy/io/tests/data/scalar_heap_pointer.sav -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/tests/data copying scipy/io/tests/data/fortran-sf8-1x1x1.dat -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/tests/data copying scipy/io/tests/data/fortran-sf8-1x1x7.dat -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/tests/data copying scipy/io/tests/data/scalar_int32.sav -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/tests/data copying scipy/io/tests/data/array_float32_pointer_7d.sav -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/tests/data copying scipy/io/tests/data/test-44100Hz-le-1ch-4bytes.wav -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/tests/data copying scipy/io/tests/data/example_2.nc -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/tests/data copying scipy/io/tests/data/scalar_int16.sav -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/tests/data copying scipy/io/tests/data/scalar_uint16.sav -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/tests/data copying scipy/io/tests/data/scalar_uint32.sav -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/tests/data copying scipy/io/tests/data/fortran-mixed.dat -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/tests/data copying scipy/io/tests/data/struct_scalars_replicated_3d.sav -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/tests/data copying scipy/io/tests/data/fortran-sf8-1x3x5.dat -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/tests/data copying scipy/io/tests/data/fortran-si4-1x1x5.dat -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/tests/data copying scipy/io/tests/data/fortran-sf8-11x1x10.dat -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/tests/data copying scipy/io/tests/data/array_float32_6d.sav -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/tests/data copying scipy/io/tests/data/array_float32_pointer_3d.sav -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/tests/data copying scipy/io/tests/data/array_float32_pointer_8d.sav -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/tests/data copying scipy/io/tests/data/scalar_complex32.sav -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/tests/data copying scipy/io/tests/data/array_float32_3d.sav -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/tests/data copying scipy/io/tests/data/array_float32_7d.sav -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/tests/data copying scipy/io/tests/data/struct_inherit.sav -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/tests/data copying scipy/io/tests/data/scalar_byte_descr.sav -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/tests/data copying scipy/io/tests/data/test-44100Hz-le-1ch-4bytes-early-eof.wav -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/tests/data copying scipy/io/tests/data/struct_arrays_replicated_3d.sav -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/tests/data copying scipy/io/tests/data/test-8000Hz-le-2ch-1byteu.wav -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/tests/data copying scipy/io/tests/data/fortran-sf8-15x10x22.dat -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/tests/data copying scipy/io/tests/data/array_float32_1d.sav -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/tests/data copying scipy/io/tests/data/struct_arrays_replicated.sav -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/tests/data copying scipy/io/tests/data/array_float32_pointer_5d.sav -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/tests/data copying scipy/io/tests/data/array_float32_5d.sav -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/tests/data copying scipy/io/tests/data/struct_pointer_arrays_replicated.sav -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/tests/data copying scipy/io/tests/data/null_pointer.sav -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/tests/data copying scipy/io/tests/data/fortran-si4-1x3x5.dat -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/tests/data copying scipy/io/tests/data/scalar_int64.sav -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/tests/data creating /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/fftpack/tests copying scipy/fftpack/tests/test_import.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/fftpack/tests/ copying scipy/fftpack/tests/fftw_dct.c -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/fftpack/tests/ copying scipy/fftpack/tests/gendata.m -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/fftpack/tests/ copying scipy/fftpack/tests/test_real_transforms.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/fftpack/tests/ copying scipy/fftpack/tests/test.npz -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/fftpack/tests/ copying scipy/fftpack/tests/fftw_double_ref.npz -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/fftpack/tests/ copying scipy/fftpack/tests/gendata.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/fftpack/tests/ copying scipy/fftpack/tests/test_basic.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/fftpack/tests/ copying scipy/fftpack/tests/fftw_single_ref.npz -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/fftpack/tests/ copying scipy/fftpack/tests/gen_fftw_ref.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/fftpack/tests/ copying scipy/fftpack/tests/__init__.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/fftpack/tests/ copying scipy/fftpack/tests/Makefile -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/fftpack/tests/ copying scipy/fftpack/tests/test_pseudo_diffs.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/fftpack/tests/ copying scipy/fftpack/tests/test_helper.py -> /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/fftpack/tests/ running install_clib running install_egg_info running egg_info creating scipy.egg-info writing scipy.egg-info/PKG-INFO writing top-level names to scipy.egg-info/top_level.txt writing dependency_links to scipy.egg-info/dependency_links.txt writing manifest file 'scipy.egg-info/SOURCES.txt' reading manifest file 'scipy.egg-info/SOURCES.txt' reading manifest template 'MANIFEST.in' no previously-included directories found matching 'benchmarks/env' no previously-included directories found matching 'benchmarks/results' no previously-included directories found matching 'benchmarks/html' no previously-included directories found matching 'benchmarks/scipy' no previously-included directories found matching 'scipy/special/tests/data/boost' no previously-included directories found matching 'scipy/special/tests/data/gsl' no previously-included directories found matching 'doc/build' no previously-included directories found matching 'doc/source/generated' no previously-included directories found matching '*/__pycache__' warning: no previously-included files matching '*~' found anywhere in distribution warning: no previously-included files matching '*.bak' found anywhere in distribution warning: no previously-included files matching '*.swp' found anywhere in distribution warning: no previously-included files matching '*.pyo' found anywhere in distribution writing manifest file 'scipy.egg-info/SOURCES.txt' Copying scipy.egg-info to /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy-1.0.0-py2.7.egg-info running install_scripts + /usr/lib/rpm/find-debuginfo.sh -j8 --strict-build-id -m -i --build-id-seed 1.0.0-20.module_el8.3.0+437+1442f53f --unique-debug-suffix -1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le --unique-debug-src-base scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le --run-dwz --dwz-low-mem-die-limit 10000000 --dwz-max-die-limit 50000000 -S debugsourcefiles.list /builddir/build/BUILD/scipy-1.0.0 extracting debug info from /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/cluster/_hierarchy.so extracting debug info from /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/_lib/messagestream.so extracting debug info from /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/cluster/_vq.so extracting debug info from /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/_lib/_test_ccallback.so extracting debug info from /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/cluster/_optimal_leaf_ordering.so extracting debug info from /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/_lib/_fpumode.so extracting debug info from /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/_lib/_ccallback_c.so extracting debug info from /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/fftpack/_fftpack.so extracting debug info from /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/fftpack/convolve.so extracting debug info from /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/integrate/_dop.so extracting debug info from /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/integrate/_odepack.so extracting debug info from /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/integrate/_quadpack.so extracting debug info from /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/integrate/_test_multivariate.so extracting debug info from /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/integrate/_test_odeint_banded.so extracting debug info from /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/integrate/lsoda.so extracting debug info from /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/integrate/vode.so extracting debug info from /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/interpolate/_bspl.so extracting debug info from /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/interpolate/_fitpack.so extracting debug info from /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/interpolate/_interpolate.so extracting debug info from /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/interpolate/_ppoly.so extracting debug info from /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/interpolate/dfitpack.so extracting debug info from /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/interpolate/interpnd.so extracting debug info from /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/_test_fortran.so extracting debug info from /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/matlab/mio5_utils.so extracting debug info from /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/matlab/mio_utils.so extracting debug info from /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/io/matlab/streams.so extracting debug info from /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/linalg/_decomp_update.so extracting debug info from /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/linalg/_fblas.so extracting debug info from /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/linalg/_flinalg.so extracting debug info from /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/linalg/_flapack.so extracting debug info from /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/linalg/_interpolative.so extracting debug info from /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/linalg/_solve_toeplitz.so extracting debug info from /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/linalg/cython_blas.so extracting debug info from /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/linalg/cython_lapack.so extracting debug info from /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/ndimage/_ctest.so extracting debug info from /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/ndimage/_ctest_oldapi.so extracting debug info from /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/ndimage/_cytest.so extracting debug info from /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/ndimage/_nd_image.so extracting debug info from /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/odr/__odrpack.so extracting debug info from /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/ndimage/_ni_label.so extracting debug info from /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/optimize/_cobyla.so extracting debug info from /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/optimize/_group_columns.so extracting debug info from /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/optimize/_lbfgsb.so extracting debug info from /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/optimize/_lsq/givens_elimination.so extracting debug info from /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/optimize/_minpack.so extracting debug info from /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/optimize/_nnls.so extracting debug info from /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/optimize/_slsqp.so extracting debug info from /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/optimize/_zeros.so extracting debug info from /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/optimize/_trlib/_trlib.so extracting debug info from /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/optimize/minpack2.so extracting debug info from /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/optimize/moduleTNC.so extracting debug info from /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/signal/_max_len_seq_inner.so extracting debug info from /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/signal/_spectral.so extracting debug info from /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/signal/_upfirdn_apply.so extracting debug info from /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/signal/sigtools.so extracting debug info from /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/signal/spline.so extracting debug info from /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/sparse/_csparsetools.so extracting debug info from /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/sparse/_sparsetools.so extracting debug info from /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/sparse/csgraph/_min_spanning_tree.so extracting debug info from /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/sparse/csgraph/_reordering.so extracting debug info from /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/sparse/csgraph/_shortest_path.so extracting debug info from /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/sparse/csgraph/_tools.so extracting debug info from /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/sparse/csgraph/_traversal.so extracting debug info from /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/sparse/linalg/dsolve/_superlu.so extracting debug info from /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/sparse/linalg/eigen/arpack/_arpack.so extracting debug info from /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/sparse/linalg/isolve/_iterative.so extracting debug info from /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/spatial/_distance_wrap.so extracting debug info from /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/spatial/_hausdorff.so extracting debug info from /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/spatial/_voronoi.so extracting debug info from /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/spatial/ckdtree.so extracting debug info from /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/special/_comb.so extracting debug info from /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/special/_ellip_harm_2.so extracting debug info from /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/spatial/qhull.so extracting debug info from /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/special/_test_round.so extracting debug info from /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/special/_ufuncs.so extracting debug info from /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/special/_ufuncs_cxx.so extracting debug info from /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/special/cython_special.so extracting debug info from /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/special/specfun.so extracting debug info from /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/stats/_stats.so extracting debug info from /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/stats/statlib.so extracting debug info from /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy/stats/mvn.so /usr/lib/rpm/sepdebugcrcfix: Updated 81 CRC32s, 0 CRC32s did match. cpio: debug.h: Cannot stat: No such file or directory cpio: stat.h: Cannot stat: No such file or directory 121086 blocks + /usr/lib/rpm/check-buildroot + /usr/lib/rpm/redhat/brp-ldconfig /sbin/ldconfig: Warning: ignoring configuration file that cannot be opened: /etc/ld.so.conf: No such file or directory + /usr/lib/rpm/brp-compress + /usr/lib/rpm/brp-strip-static-archive /usr/bin/strip + /usr/lib/rpm/brp-python-bytecompile '' 1 Bytecompiling .py files below /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7 using /usr/bin/python2.7 Bytecompiling .py files below /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib/debug/usr/lib64/python2.7 using /usr/bin/python2.7 + /usr/lib/rpm/brp-python-hardlink + PYTHON3=/usr/libexec/platform-python + /usr/lib/rpm/redhat/brp-mangle-shebangs Executing(%check): /bin/sh -e /var/tmp/rpm-tmp.iHiwBQ ~/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages ~/build/BUILD/scipy-1.0.0 + umask 022 + cd /builddir/build/BUILD + cd scipy-1.0.0 + pushd /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le//usr/lib64/python2.7/site-packages + py.test-2.7 -k 'not test_denormals' scipy ============================= test session starts ============================== platform linux2 -- Python 2.7.17, pytest-3.4.2, py-1.5.3, pluggy-0.6.0 rootdir: /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/lib64/python2.7/site-packages/scipy, inifile: collected 14095 items scipy/_lib/tests/test__gcutils.py ...... [ 0%] scipy/_lib/tests/test__testutils.py .. [ 0%] scipy/_lib/tests/test__threadsafety.py .. [ 0%] scipy/_lib/tests/test__util.py .. [ 0%] scipy/_lib/tests/test__version.py ........ [ 0%] scipy/_lib/tests/test_ccallback.py ss.. [ 0%] scipy/_lib/tests/test_tmpdirs.py ... [ 0%] scipy/_lib/tests/test_warnings.py ss [ 0%] scipy/cluster/tests/test_hierarchy.py .................................. [ 0%] .............................................ss........ [ 0%] scipy/cluster/tests/test_vq.py ...................... [ 0%] scipy/constants/tests/test_codata.py ....... [ 1%] scipy/constants/tests/test_constants.py ... [ 1%] scipy/fftpack/tests/test_basic.py ..........x........................... [ 1%] .................................. [ 1%] scipy/fftpack/tests/test_helper.py ...... [ 1%] scipy/fftpack/tests/test_pseudo_diffs.py ............................. [ 1%] scipy/fftpack/tests/test_real_transforms.py ............................ [ 2%] ..................................... [ 2%] scipy/integrate/tests/test_banded_ode_solvers.py . [ 2%] scipy/integrate/tests/test_bvp.py .............. [ 2%] scipy/integrate/tests/test_integrate.py .....................s....s....s [ 2%] ....s....s.... [ 2%] scipy/integrate/tests/test_ivp.py ............... [ 2%] scipy/integrate/tests/test_odeint_jac.py .. [ 2%] scipy/integrate/tests/test_quadpack.py ........................... [ 3%] scipy/integrate/tests/test_quadrature.py .................. [ 3%] scipy/interpolate/tests/test_bsplines.py ............................... [ 3%] ...............x................ [ 3%] scipy/interpolate/tests/test_fitpack.py ................... [ 3%] scipy/interpolate/tests/test_fitpack2.py ............................... [ 3%] . [ 3%] scipy/interpolate/tests/test_gil.py X [ 3%] scipy/interpolate/tests/test_interpnd.py .................... [ 4%] scipy/interpolate/tests/test_interpolate.py ............................ [ 4%] ........................................................................ [ 4%] ............................................... [ 5%] scipy/interpolate/tests/test_interpolate_wrapper.py ..... [ 5%] scipy/interpolate/tests/test_ndgriddata.py ........... [ 5%] scipy/interpolate/tests/test_pade.py .. [ 5%] scipy/interpolate/tests/test_polyint.py ................................ [ 5%] .............. [ 5%] scipy/interpolate/tests/test_rbf.py ........ [ 5%] scipy/interpolate/tests/test_regression.py . [ 5%] scipy/io/arff/tests/test_arffread.py ....s............. [ 5%] scipy/io/harwell_boeing/tests/test_fortran_format.py ........... [ 5%] scipy/io/harwell_boeing/tests/test_hb.py .. [ 5%] scipy/io/matlab/tests/test_byteordercodes.py .. [ 5%] scipy/io/matlab/tests/test_mio.py ...................................... [ 6%] ............... [ 6%] scipy/io/matlab/tests/test_mio5_utils.py ...... [ 6%] scipy/io/matlab/tests/test_mio_funcs.py . [ 6%] scipy/io/matlab/tests/test_mio_utils.py .. [ 6%] scipy/io/matlab/tests/test_miobase.py . [ 6%] scipy/io/matlab/tests/test_pathological.py .. [ 6%] scipy/io/matlab/tests/test_streams.py ....... [ 6%] scipy/io/tests/test_fortran.py ...... [ 6%] scipy/io/tests/test_idl.py ............................................. [ 6%] ..................... [ 6%] scipy/io/tests/test_mmio.py ............................................ [ 7%] ....... [ 7%] scipy/io/tests/test_netcdf.py ...................... [ 7%] scipy/io/tests/test_paths.py sssssssss [ 7%] scipy/io/tests/test_wavfile.py ......... [ 7%] scipy/linalg/tests/test_basic.py ....................................... [ 7%] ................s....................................................... [ 8%] ............. [ 8%] scipy/linalg/tests/test_blas.py ........................................ [ 8%] ....... [ 8%] scipy/linalg/tests/test_build.py . [ 8%] scipy/linalg/tests/test_cython_blas.py ...... [ 8%] scipy/linalg/tests/test_cython_lapack.py .. [ 8%] scipy/linalg/tests/test_decomp.py ........X............................. [ 9%] .......................................~/build/BUILD/scipy-1.0.0 /var/tmp/rpm-tmp.iHiwBQ: line 40: 11748 Aborted py.test-2.7 -k "not test_denormals" scipy + : + popd + exit 0 Processing files: python2-scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le Executing(%doc): /bin/sh -e /var/tmp/rpm-tmp.gj0q39 + umask 022 + cd /builddir/build/BUILD + cd scipy-1.0.0 + DOCDIR=/builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/share/doc/python2-scipy + export LC_ALL=C + LC_ALL=C + export DOCDIR + /usr/bin/mkdir -p /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/share/doc/python2-scipy + cp -pr LICENSE.txt /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le/usr/share/doc/python2-scipy + exit 0 warning: Deprecated external dependency generator is used! Finding Provides: /bin/sh -c " /usr/bin/grep -v '/usr/lib64/python2.7/site-packages.*\.so$' | /usr/bin/grep -v '/usr/lib64/python3.6/site-packages.*\.so$' | while read FILE; do echo "${FILE}" | /usr/lib/rpm/rpmdeps -P; done | /bin/sort -u " Finding Requires(interp): Finding Requires(rpmlib): Finding Requires(verify): Finding Requires(pre): Finding Requires(post): Finding Requires(preun): Finding Requires(postun): Finding Requires(pretrans): Finding Requires(posttrans): Finding Requires: /bin/sh -c " while read FILE; do echo "${FILE}" | /usr/lib/rpm/rpmdeps -R; done | /bin/sort -u " Finding Conflicts: Finding Obsoletes: Finding Recommends: Finding Suggests: Finding Supplements: Finding Enhances: Provides: python2-scipy = 1.0.0-20.module_el8.3.0+437+1442f53f python2-scipy(ppc-64) = 1.0.0-20.module_el8.3.0+437+1442f53f python2.7dist(scipy) = 1.0.0 python2dist(scipy) = 1.0.0 Requires(rpmlib): rpmlib(CompressedFileNames) <= 3.0.4-1 rpmlib(FileDigests) <= 4.6.0-1 rpmlib(PartialHardlinkSets) <= 4.0.4-1 rpmlib(PayloadFilesHavePrefix) <= 4.0-1 Requires: ld64.so.2()(64bit) ld64.so.2(GLIBC_2.22)(64bit) ld64.so.2(GLIBC_2.23)(64bit) libc.so.6()(64bit) libc.so.6(GLIBC_2.17)(64bit) libgcc_s.so.1()(64bit) libgcc_s.so.1(GCC_3.0)(64bit) libgcc_s.so.1(GCC_3.4.4)(64bit) libgcc_s.so.1(GCC_4.0.0)(64bit) libgfortran.so.5()(64bit) libgfortran.so.5(GFORTRAN_8)(64bit) libm.so.6()(64bit) libm.so.6(GLIBC_2.17)(64bit) libm.so.6(GLIBC_2.27)(64bit) libopenblas.so.0()(64bit) libopenblasp.so.0()(64bit) libpthread.so.0()(64bit) libpython2.7.so.1.0()(64bit) libquadmath.so.0()(64bit) libstdc++.so.6()(64bit) libstdc++.so.6(CXXABI_1.3)(64bit) libstdc++.so.6(CXXABI_1.3.9)(64bit) libstdc++.so.6(GLIBCXX_3.4)(64bit) libstdc++.so.6(GLIBCXX_3.4.21)(64bit) python(abi) = 2.7 rtld(GNU_HASH) Obsoletes: scipy <= 0.16.0 Processing files: scipy-debugsource-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le warning: Deprecated external dependency generator is used! Provides: scipy-debugsource = 1.0.0-20.module_el8.3.0+437+1442f53f scipy-debugsource(ppc-64) = 1.0.0-20.module_el8.3.0+437+1442f53f Requires(rpmlib): rpmlib(CompressedFileNames) <= 3.0.4-1 rpmlib(FileDigests) <= 4.6.0-1 rpmlib(PayloadFilesHavePrefix) <= 4.0-1 Processing files: python2-scipy-debuginfo-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le warning: Deprecated external dependency generator is used! Finding Provides: /bin/sh -c " /usr/bin/grep -v '/usr/lib64/python2.7/site-packages.*\.so$' | /usr/bin/grep -v '/usr/lib64/python3.6/site-packages.*\.so$' | while read FILE; do echo "${FILE}" | /usr/lib/rpm/rpmdeps -P; done | /bin/sort -u " Provides: debuginfo(build-id) = 023a81fd6ce24f6a966b59ea82b15d3e1ae1a766 debuginfo(build-id) = 030502e6bd57687967c90954e8caf739241991c8 debuginfo(build-id) = 06818937a5134829417f9a21138ce3b334921659 debuginfo(build-id) = 0a4af2190500c660967f891116bcc0f204d849ac debuginfo(build-id) = 0c64753258ee8b273afdebe7a0269cc1bce2e1e3 debuginfo(build-id) = 0ca6ab85681a04429139fe11ea63213192c51947 debuginfo(build-id) = 0f7d600255c84aa5cf4cc50c6231608fa7a63046 debuginfo(build-id) = 10c467bfd4456ecaf245b8595a80c9e6338d7af8 debuginfo(build-id) = 14c73db0e0127a0ef791dc2e2a419c7125d1a811 debuginfo(build-id) = 16095e27a3a8e9ddfbbbffe1c06bf292ec1a6dd4 debuginfo(build-id) = 18678ab5d3b33111461bb0f5649945f6bb3e0ec3 debuginfo(build-id) = 1cacfe0bdd20c145a1d0d36d8545541aee7a9984 debuginfo(build-id) = 1d39bc7b13f6aa7c444c8747aed2ad1a9e5a81ae debuginfo(build-id) = 1deca673d2591541b16ef47710b16a53ef1f1264 debuginfo(build-id) = 1fb70e5e97581bddd800b4a354297cabe8fc87a6 debuginfo(build-id) = 233f0de8c005bf2b637b27ef4b7e317041932ffe debuginfo(build-id) = 2a5326daba30391a2d81c077931894ba958d3a4b debuginfo(build-id) = 2e645b4ff167bb53e5245908b09dab7b87416347 debuginfo(build-id) = 2ee9ecf54ce6a54c849ddb625cd3e082d2d360d7 debuginfo(build-id) = 2f63bfcc3c826a295358450d70abfddf6d8b7bb5 debuginfo(build-id) = 30fc964fb464c5dcfcbe80b6e79e519ac84b683b debuginfo(build-id) = 3431e981ecdfc5e4e5bb73e752a140a59113200f debuginfo(build-id) = 38c412174ff2a22a76439f42e0559c19e4a1e720 debuginfo(build-id) = 3a2b6e582819df3822d617aecd34c18ecf579293 debuginfo(build-id) = 41706077d6cfc55395b33d2c4f276b1eafc26a00 debuginfo(build-id) = 43cc996b0688dcbd075e8ea95df63414a378f7fd debuginfo(build-id) = 459e6d6a2d0338a955a535af8e170142b5339285 debuginfo(build-id) = 469e80eb8134809980413210a1f91cb4ec40ae63 debuginfo(build-id) = 48b06621ead41d091e2a9e977377020f87640340 debuginfo(build-id) = 4a120c092e990882258c85b27e4c164415bceb96 debuginfo(build-id) = 4e9d71840e0876775502b1d88ecc341034751e88 debuginfo(build-id) = 4f4b4c15c45efcaf5dc796800e9e646326396067 debuginfo(build-id) = 509d8b143f8d918cd0baea864421195055988ee9 debuginfo(build-id) = 5197bd79253d38cff7da02dd907278309afe9af3 debuginfo(build-id) = 57c7e964020cd83ef8304e5c80290947c01ec490 debuginfo(build-id) = 586289af134c23090fbc17a80463b2d49c850440 debuginfo(build-id) = 597c5e63dbf5a2065d16b76b40fa204ff51e1cb7 debuginfo(build-id) = 5a79e58358697edfbd802554927e3cb2e66c6605 debuginfo(build-id) = 6259b9e7f25a59275b696b75a8c536e55ed2aa91 debuginfo(build-id) = 640a86fb52d2d3a94e432547e96a8f9c0985d02a debuginfo(build-id) = 6609625763993de613499ecef5f0b129cecd6ab3 debuginfo(build-id) = 6bacd86577836700c2d9135126f83b8365099c03 debuginfo(build-id) = 6dadf284b70d4eb324cc42c56b8b1b195ce40784 debuginfo(build-id) = 6dff484ac920521d3998c32617260198a625d670 debuginfo(build-id) = 7ab0ed2475e46bcbd52bcf954f06c6293869956f debuginfo(build-id) = 7f7e859eef36a6c58685b68193a37c8c96dab02f debuginfo(build-id) = 7fa188edcada23f3907651eb59eca20c101b751c debuginfo(build-id) = 8364cc53c5d70bbead5ab37623df9636092edccb debuginfo(build-id) = 85e745cdaa7320d9d01ecfe66bb42f05e19e3a9c debuginfo(build-id) = 9169f6ccaa69db267388a74c02c227ede8ee4d48 debuginfo(build-id) = 92ba7a8dfb080a4fe395cb77841c8a6d3df40658 debuginfo(build-id) = 941189cfde84f18a8315c4e88a5a74088ae84ce3 debuginfo(build-id) = 986ee996d755ec823c4329f83369f89282f5604f debuginfo(build-id) = 9882aa7ff3b087c98b308dc8fa839ecd43a7f1c1 debuginfo(build-id) = 9b41cf3293f44c265b1ff46ac410343967778b88 debuginfo(build-id) = a1ea9bae62779747ea44a47f8388fe44a2cce1f8 debuginfo(build-id) = a2e4e3b01773379988e77885a1876baac9c83338 debuginfo(build-id) = a3a4adc4874456ce61f6f92daceaad8eae932565 debuginfo(build-id) = a979afdc594384264e7591a4bdef78fb969a43b0 debuginfo(build-id) = ab3d836fd5472dd1eccb3ba1a7322f5a29fd4401 debuginfo(build-id) = aea99d1504874ae5873bddb0dc9c313046231476 debuginfo(build-id) = b0241f28d23b43ad053f774abb04d68a4cbaf9fa debuginfo(build-id) = b54464ba6a6394602e4d5b13c04c6c031b2244db debuginfo(build-id) = c11ee9dbc85d8b27924ebbe35555303fbbecf7dd debuginfo(build-id) = c2d73591af0db958693bfb443ad11821f154385f debuginfo(build-id) = c379d73e535c4e2d3019bc970ca73d4a55d7869e debuginfo(build-id) = c77326cbcbcda4c1df68d9f4d4018e9592533fe0 debuginfo(build-id) = c9cf713acf19e01260aeff1d772efd13afbe9abf debuginfo(build-id) = c9f2de2d5dbacd44ea222540ae242d851c3e3e29 debuginfo(build-id) = ce9c186a5ad5ead8b6a42d2699addb5ffee658ad debuginfo(build-id) = cef799f8668d8bff70e69b6314aab54e38a2e42e debuginfo(build-id) = cfab4f35a7da3c0f3ff0e507a88ef12dc88ad505 debuginfo(build-id) = d0755f692f48c266246cf9ade58a8ab90bcaef1d debuginfo(build-id) = d7b745d139cc8bb12b3f843b6e35d0814c478c87 debuginfo(build-id) = e1190151a123f00b18c681375a7b761bb0e9996d debuginfo(build-id) = e1a9e592a1dfb6f6f635c703f707dc31c10edc9c debuginfo(build-id) = e6bb329e521b111c75ebd1667757757d0fcc47d7 debuginfo(build-id) = ea537cff1ccd4c458c9c58c0836f0faa2a650795 debuginfo(build-id) = eff27c7094df954808acb8a3dd7d23ed5c28a3b5 debuginfo(build-id) = f13f56898ac54263355ab68638439ee58f751c44 debuginfo(build-id) = f8766375e599e173f94617328361ff27850192d3 python2-scipy-debuginfo = 1.0.0-20.module_el8.3.0+437+1442f53f python2-scipy-debuginfo(ppc-64) = 1.0.0-20.module_el8.3.0+437+1442f53f Requires(rpmlib): rpmlib(CompressedFileNames) <= 3.0.4-1 rpmlib(FileDigests) <= 4.6.0-1 rpmlib(PayloadFilesHavePrefix) <= 4.0-1 Recommends: scipy-debugsource(ppc-64) = 1.0.0-20.module_el8.3.0+437+1442f53f Checking for unpackaged file(s): /usr/lib/rpm/check-files /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le Wrote: /builddir/build/RPMS/python2-scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le.rpm Wrote: /builddir/build/RPMS/scipy-debugsource-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le.rpm Wrote: /builddir/build/RPMS/python2-scipy-debuginfo-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le.rpm Executing(%clean): /bin/sh -e /var/tmp/rpm-tmp.rtAGej + umask 022 + cd /builddir/build/BUILD + cd scipy-1.0.0 + /usr/bin/rm -rf /builddir/build/BUILDROOT/scipy-1.0.0-20.module_el8.3.0+437+1442f53f.ppc64le + exit 0 Child return code was: 0