[SciPy-user] Wrapping mebdfdae.f

Nils Wagner nwagner at iam.uni-stuttgart.de
Thu Oct 9 13:35:32 EDT 2008


Hi all,

I tried to wrap mebdfdae.f
http://www.ma.ic.ac.uk/~jcash/IVP_software_BSD/mebdfdae.f

If failed with

f2py -c -m mebdfdae mebdfdae.f
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
building extension "mebdfdae" sources
f2py options: []
f2py:> /tmp/tmp9spUor/src.linux-i686-2.4/mebdfdaemodule.c
creating /tmp/tmp9spUor
creating /tmp/tmp9spUor/src.linux-i686-2.4
Reading fortran codes...
         Reading file 'mebdfdae.f' (format:fix,strict)
Post-processing...
         Block: mebdfdae
                         Block: mebdf
                         Block: ovdriv
                         Block: interp
                         Block: coset
                         Block: pset
                                         Block: pderv
                                         Block: f
                         Block: dec
                         Block: sol
                         Block: dgbfa
                         Block: daxpy
                         Block: dscal
                         Block: idamax
                         Block: dgbsl
                         Block: ddot
                         Block: errors
                         Block: prdict
                                         Block: f
                         Block: itrat2
                                         Block: f
                         Block: stiff
                                         Block: f
                                         Block: mas
                         Block: rscale
                         Block: cpyary
                         Block: hchose
                         Block: dlamch
                         Block: dlamc1
                         Block: dlamc2
                         Block: dlamc3
                         Block: dlamc4
                         Block: dlamc5
                         Block: lsame
Post-processing (stage 2)...
Building modules...
         Constructing call-back function 
"cb_f_in_pset__user__routines"
getarrdims:warning: assumed shape array, using 0 instead 
of '*'
getarrdims:warning: assumed shape array, using 0 instead 
of '*'
           def f(t,y,wrkspc,ipar,rpar,ierr,[n]): return
         Constructing call-back function 
"cb_pderv_in_pset__user__routines"
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 '*'
           def pderv(t,y,pwcopy,ipar,rpar,ierr,[n,n]): 
return
         Constructing call-back function 
"cb_f_in_prdict__user__routines"
getarrdims:warning: assumed shape array, using 0 instead 
of '*'
getarrdims:warning: assumed shape array, using 0 instead 
of '*'
           def f(t,y,yprime,ipar,rpar,ierr,[n]): return
         Constructing call-back function 
"cb_f_in_itrat2__user__routines"
getarrdims:warning: assumed shape array, using 0 instead 
of '*'
getarrdims:warning: assumed shape array, using 0 instead 
of '*'
           def f(t,save1,save2,ipar,rpar,ierr,[n]): return
         Constructing call-back function 
"cb_f_in_stiff__user__routines"
getarrdims:warning: assumed shape array, using 0 instead 
of '*'
getarrdims:warning: assumed shape array, using 0 instead 
of '*'
           def f(t,y,save1,ipar,rpar,ierr,[n]): return
         Constructing call-back function 
"cb_mas_in_stiff__user__routines"
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 '*'
           def mas(n,am,ldmas,ipar,rpar,ierr): return
         Building module "mebdfdae"...
                 Constructing wrapper function "mebdf"...
routsign2map: Confused: function mebdf has externals ['f', 
'pderv', 'mas'] but no "use" statement.
getarrdims:warning: assumed shape array, using 0 instead 
of '*'
getarrdims:warning: assumed shape array, using 0 instead 
of '*'
sign2map: Confused: external f is not in lcb_map[].
append_needs: unknown need 'f'
append_needs: unknown need 'f'
sign2map: Confused: external pderv is not in lcb_map[].
append_needs: unknown need 'pderv'
append_needs: unknown need 'pderv'
sign2map: Confused: external mas is not in lcb_map[].
append_needs: unknown need 'mas'
append_needs: unknown need 'mas'
                   mebdf(t0,ho,y0,tout,tend,mf,idid,lout,work,iwork,mbnd,masbnd,maxder,itol,rtol,atol,rpar,ipar,f,pderv,mas,ierr,[n,lwork,liwork,f_extra_args,pderv_extra_args,mas_extra_args])
                 Constructing wrapper function "ovdriv"...
routsign2map: Confused: function ovdriv has externals 
['f', 'pderv', 'mas'] but no "use" statement.
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 '*'
sign2map: Confused: external f is not in lcb_map[].
append_needs: unknown need 'f'
append_needs: unknown need 'f'
sign2map: Confused: external pderv is not in lcb_map[].
append_needs: unknown need 'pderv'
append_needs: unknown need 'pderv'
sign2map: Confused: external mas is not in lcb_map[].
append_needs: unknown need 'mas'
append_needs: unknown need 'mas'
                   ovdriv(t0,ho,y0,tout,tend,mf,idid,lout,y,yhold,ynhold,ymax,errors,save1,save2,scale,arh,pw,pwcopy,am,ipiv,mbnd,masbnd,nind1,nind2,nind3,maxder,itol,rtol,atol,rpar,ipar,f,pderv,mas,nqused,nstep,nfail,nfe,nje,ndec,nbsol,npset,ncoset,maxord,maxstp,uround,hused,epsjac,ierr,[n,f_extra_args,pderv_extra_args,mas_extra_args])
                 Constructing wrapper function "interp"...
                   interp(jstart,h,t,y,tout,y0,[n])
                 Constructing wrapper function "coset"...
                   coset(nq,el,elst,tq,ncoset,maxord)
                 Constructing wrapper function "pset"...
sign2map: Confused: external mas is not in 
lcb_map['pderv', 'f'].
append_needs: unknown need 'mas'
append_needs: unknown need 'mas'
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 '*'
                   pset(y,h,t,uround,epsjac,con,miter,mbnd,masbnd,nind1,nind2,nind3,ier,f,pderv,mas,nrenew,ymax,save1,save2,pw,pwcopy,am,wrkspc,ipiv,itol,rtol,atol,npset,nje,nfe,ndec,ipar,rpar,ierr,[n,f_extra_args,pderv_extra_args,mas_extra_args])
                 Constructing wrapper function "dec"...
                   dec(a,ip,ier,[n,ndim])
                 Constructing wrapper function "sol"...
                   sol(a,b,ip,[n,ndim])
                 Constructing wrapper function "dgbfa"...
                   dgbfa(abd,n,ml,mu,ipvt,info,[lda])
                 Constructing wrapper function "daxpy"...
                   daxpy(n,da,dx,incx,dy,incy)
                 Constructing wrapper function "dscal"...
                   dscal(n,da,dx,incx)
                 Creating wrapper for Fortran function 
"idamax"("idamax")...
                 Constructing wrapper function "idamax"...
                   idamax = idamax(n,dx,incx)
                 Constructing wrapper function "dgbsl"...
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 '*'
                   dgbsl(abd,n,ml,mu,ipvt,b,job,[lda])
                 Creating wrapper for Fortran function 
"ddot"("ddot")...
                 Constructing wrapper function "ddot"...
                   ddot = ddot(n,dx,incx,dy,incy)
                 Constructing wrapper function "errors"...
                   errors(n,tq,edn,e,eup,bnd,eddn)
                 Constructing wrapper function "prdict"...
getarrdims:warning: assumed shape array, using 0 instead 
of '*'
getarrdims:warning: assumed shape array, using 0 instead 
of '*'
                   prdict(t,h,y,l,yprime,nfe,ipar,rpar,f,ierr,[n,f_extra_args])
                 Constructing wrapper function "itrat2"...
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 '*'
                   itrat2(qqq,y,t,hbeta,errbnd,arh,crate,tcrate,m,worked,ymax,error,save1,save2,scale,pw,mf,mbnd,am,masbnd,nind1,nind2,nind3,ipiv,lmb,itol,rtol,atol,ipar,rpar,hused,nbsol,nfe,nqused,f,ierr,[n,f_extra_args])
                 Constructing wrapper function "stiff"...
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 '*'
sign2map: Confused: external pderv is not in 
lcb_map['mas', 'f'].
append_needs: unknown need 'pderv'
append_needs: unknown need 'pderv'
                   stiff(h,hmax,hmin,jstart,kflag,mf,mbnd,masbnd,nind1,nind2,nind3,t,tout,tend,y,ymax,error,save1,save2,scale,pw,pwcopy,am,yhold,ynhold,arh,ipiv,lout,maxder,itol,rtol,atol,rpar,ipar,f,pderv,mas,nqused,nstep,nfail,nfe,nje,ndec,nbsol,npset,ncoset,maxord,maxstp,uround,epsjac,hused,ierr,[n,f_extra_args,pderv_extra_args,mas_extra_args])
                 Constructing wrapper function "rscale"...
                   rscale(l,rh,y,[n])
                 Constructing wrapper function "cpyary"...
                   cpyary(source,target,[nelem])
                 Constructing wrapper function "hchose"...
                   hchose(rh,h,ovride)
                 Creating wrapper for Fortran function 
"dlamch"("dlamch")...
                 Constructing wrapper function "dlamch"...
                   dlamch = dlamch(cmach)
                 Constructing wrapper function "dlamc1"...
                   dlamc1(beta,t,rnd,ieee1)
                 Constructing wrapper function "dlamc2"...
                   dlamc2(beta,t,rnd,eps,emin,rmin,emax,rmax)
                 Creating wrapper for Fortran function 
"dlamc3"("dlamc3")...
                 Constructing wrapper function "dlamc3"...
                   dlamc3 = dlamc3(a,b)
                 Constructing wrapper function "dlamc4"...
                   dlamc4(emin,start,base)
                 Constructing wrapper function "dlamc5"...
                   dlamc5(beta,p,emin,ieee,emax,rmax)
                 Creating wrapper for Fortran function 
"lsame"("lsame")...
                 Constructing wrapper function "lsame"...
                   lsame = lsame(ca,cb)
                 Constructing COMMON block support for 
"stpsze"...
                   hstpsz
         Wrote C/API module "mebdfdae" to file 
"/tmp/tmp9spUor/src.linux-i686-2.4/mebdfdaemodule.c"
         Fortran 77 wrappers are saved to 
"/tmp/tmp9spUor/src.linux-i686-2.4/mebdfdae-f2pywrappers.f"
   adding 
'/tmp/tmp9spUor/src.linux-i686-2.4/fortranobject.c' to 
sources.
   adding '/tmp/tmp9spUor/src.linux-i686-2.4' to 
include_dirs.
copying 
/usr/lib/python2.4/site-packages/numpy/f2py/src/fortranobject.c 
-> /tmp/tmp9spUor/src.linux-i686-2.4
copying 
/usr/lib/python2.4/site-packages/numpy/f2py/src/fortranobject.h 
-> /tmp/tmp9spUor/src.linux-i686-2.4
   adding 
'/tmp/tmp9spUor/src.linux-i686-2.4/mebdfdae-f2pywrappers.f' 
to sources.
running build_ext
customize UnixCCompiler
customize UnixCCompiler using build_ext
customize GnuFCompiler
Found executable /usr/bin/g77
gnu: no Fortran 90 compiler found
gnu: no Fortran 90 compiler found
customize GnuFCompiler
gnu: no Fortran 90 compiler found
gnu: no Fortran 90 compiler found
customize GnuFCompiler using build_ext
building 'mebdfdae' extension
compiling C sources
C compiler: gcc -pthread -fno-strict-aliasing -DNDEBUG -O2 
-march=i586 -mcpu=i686 -fmessage-length=0 -Wall -g -fPIC

creating /tmp/tmp9spUor/tmp
creating /tmp/tmp9spUor/tmp/tmp9spUor
creating /tmp/tmp9spUor/tmp/tmp9spUor/src.linux-i686-2.4
compile options: '-I/tmp/tmp9spUor/src.linux-i686-2.4 
-I/usr/lib/python2.4/site-packages/numpy/core/include 
-I/usr/include/python2.4 -c'
gcc: /tmp/tmp9spUor/src.linux-i686-2.4/mebdfdaemodule.c
/tmp/tmp9spUor/src.linux-i686-2.4/mebdfdaemodule.c:599: 
error: redefinition of `n_cb_capi'
/tmp/tmp9spUor/src.linux-i686-2.4/mebdfdaemodule.c:599: 
error: `n_cb_capi' previously declared here
/tmp/tmp9spUor/src.linux-i686-2.4/mebdfdaemodule.c: In 
function `cb_pderv_in_pset__user__routines':
/tmp/tmp9spUor/src.linux-i686-2.4/mebdfdaemodule.c:599: 
error: redeclaration of `n_cb_capi'
/tmp/tmp9spUor/src.linux-i686-2.4/mebdfdaemodule.c:599: 
error: `n_cb_capi' previously declared here
/tmp/tmp9spUor/src.linux-i686-2.4/mebdfdaemodule.c:608: 
error: redeclaration of `n'
/tmp/tmp9spUor/src.linux-i686-2.4/mebdfdaemodule.c:607: 
error: `n' previously declared here
/tmp/tmp9spUor/src.linux-i686-2.4/mebdfdaemodule.c:607: 
warning: unused variable `n'
/tmp/tmp9spUor/src.linux-i686-2.4/mebdfdaemodule.c: In 
function `f2py_rout_mebdfdae_mebdf':
/tmp/tmp9spUor/src.linux-i686-2.4/mebdfdaemodule.c:1467: 
error: `f_typedef' undeclared (first use in this function)
/tmp/tmp9spUor/src.linux-i686-2.4/mebdfdaemodule.c:1467: 
error: (Each undeclared identifier is reported only once
/tmp/tmp9spUor/src.linux-i686-2.4/mebdfdaemodule.c:1467: 
error: for each function it appears in.)
/tmp/tmp9spUor/src.linux-i686-2.4/mebdfdaemodule.c:1467: 
error: syntax error before "f_cptr"
/tmp/tmp9spUor/src.linux-i686-2.4/mebdfdaemodule.c:1472: 
error: `pderv_typedef' undeclared (first use in this 
function)
/tmp/tmp9spUor/src.linux-i686-2.4/mebdfdaemodule.c:1472: 
error: syntax error before "pderv_cptr"
/tmp/tmp9spUor/src.linux-i686-2.4/mebdfdaemodule.c:1477: 
error: `mas_typedef' undeclared (first use in this 
function)
/tmp/tmp9spUor/src.linux-i686-2.4/mebdfdaemodule.c:1477: 
error: syntax error before "mas_cptr"
/tmp/tmp9spUor/src.linux-i686-2.4/mebdfdaemodule.c:1555: 
error: `pderv_cptr' undeclared (first use in this 
function)
/tmp/tmp9spUor/src.linux-i686-2.4/mebdfdaemodule.c:1557: 
error: `pderv' undeclared (first use in this function)
/tmp/tmp9spUor/src.linux-i686-2.4/mebdfdaemodule.c:1560: 
error: `pderv_nofargs' undeclared (first use in this 
function)
/tmp/tmp9spUor/src.linux-i686-2.4/mebdfdaemodule.c:1561: 
error: syntax error at '#' token
/tmp/tmp9spUor/src.linux-i686-2.4/mebdfdaemodule.c:1561: 
error: syntax error at '#' token
/tmp/tmp9spUor/src.linux-i686-2.4/mebdfdaemodule.c:1561: 
error: `maxnofargs' undeclared (first use in this 
function)
/tmp/tmp9spUor/src.linux-i686-2.4/mebdfdaemodule.c:1561: 
error: syntax error at '#' token
/tmp/tmp9spUor/src.linux-i686-2.4/mebdfdaemodule.c:1561: 
error: syntax error at '#' token
/tmp/tmp9spUor/src.linux-i686-2.4/mebdfdaemodule.c:1561: 
error: `nofoptargs' undeclared (first use in this 
function)
/tmp/tmp9spUor/src.linux-i686-2.4/mebdfdaemodule.c:1572: 
error: `mas_cptr' undeclared (first use in this function)
/tmp/tmp9spUor/src.linux-i686-2.4/mebdfdaemodule.c:1574: 
error: `mas' undeclared (first use in this function)
/tmp/tmp9spUor/src.linux-i686-2.4/mebdfdaemodule.c:1577: 
error: `mas_nofargs' undeclared (first use in this 
function)
/tmp/tmp9spUor/src.linux-i686-2.4/mebdfdaemodule.c:1578: 
error: syntax error at '#' token
/tmp/tmp9spUor/src.linux-i686-2.4/mebdfdaemodule.c:1578: 
error: syntax error at '#' token
/tmp/tmp9spUor/src.linux-i686-2.4/mebdfdaemodule.c:1578: 
error: syntax error at '#' token
/tmp/tmp9spUor/src.linux-i686-2.4/mebdfdaemodule.c:1578: 
error: syntax error at '#' token
/tmp/tmp9spUor/src.linux-i686-2.4/mebdfdaemodule.c:1612: 
error: `f_cptr' undeclared (first use in this function)
/tmp/tmp9spUor/src.linux-i686-2.4/mebdfdaemodule.c:1614: 
error: `f' undeclared (first use in this function)
/tmp/tmp9spUor/src.linux-i686-2.4/mebdfdaemodule.c:1617: 
error: `f_nofargs' undeclared (first use in this function)
/tmp/tmp9spUor/src.linux-i686-2.4/mebdfdaemodule.c:1618: 
error: syntax error at '#' token
/tmp/tmp9spUor/src.linux-i686-2.4/mebdfdaemodule.c:1618: 
error: syntax error at '#' token
/tmp/tmp9spUor/src.linux-i686-2.4/mebdfdaemodule.c:1618: 
error: syntax error at '#' token
/tmp/tmp9spUor/src.linux-i686-2.4/mebdfdaemodule.c:1618: 
error: syntax error at '#' token
/tmp/tmp9spUor/src.linux-i686-2.4/mebdfdaemodule.c: In 
function `f2py_rout_mebdfdae_ovdriv':
/tmp/tmp9spUor/src.linux-i686-2.4/mebdfdaemodule.c:2020: 
error: `f_typedef' undeclared (first use in this function)
/tmp/tmp9spUor/src.linux-i686-2.4/mebdfdaemodule.c:2020: 
error: syntax error before "f_cptr"
/tmp/tmp9spUor/src.linux-i686-2.4/mebdfdaemodule.c:2025: 
error: `pderv_typedef' undeclared (first use in this 
function)
/tmp/tmp9spUor/src.linux-i686-2.4/mebdfdaemodule.c:2025: 
error: syntax error before "pderv_cptr"
/tmp/tmp9spUor/src.linux-i686-2.4/mebdfdaemodule.c:2030: 
error: `mas_typedef' undeclared (first use in this 
function)
/tmp/tmp9spUor/src.linux-i686-2.4/mebdfdaemodule.c:2030: 
error: syntax error before "mas_cptr"
/tmp/tmp9spUor/src.linux-i686-2.4/mebdfdaemodule.c:2164: 
error: `pderv_cptr' undeclared (first use in this 
function)
/tmp/tmp9spUor/src.linux-i686-2.4/mebdfdaemodule.c:2166: 
error: `pderv' undeclared (first use in this function)
/tmp/tmp9spUor/src.linux-i686-2.4/mebdfdaemodule.c:2169: 
error: `pderv_nofargs' undeclared (first use in this 
function)
/tmp/tmp9spUor/src.linux-i686-2.4/mebdfdaemodule.c:2170: 
error: syntax error at '#' token
/tmp/tmp9spUor/src.linux-i686-2.4/mebdfdaemodule.c:2170: 
error: syntax error at '#' token
/tmp/tmp9spUor/src.linux-i686-2.4/mebdfdaemodule.c:2170: 
error: `maxnofargs' undeclared (first use in this 
function)
/tmp/tmp9spUor/src.linux-i686-2.4/mebdfdaemodule.c:2170: 
error: syntax error at '#' token
/tmp/tmp9spUor/src.linux-i686-2.4/mebdfdaemodule.c:2170: 
error: syntax error at '#' token
/tmp/tmp9spUor/src.linux-i686-2.4/mebdfdaemodule.c:2170: 
error: `nofoptargs' undeclared (first use in this 
function)
/tmp/tmp9spUor/src.linux-i686-2.4/mebdfdaemodule.c:2184: 
error: `mas_cptr' undeclared (first use in this function)
/tmp/tmp9spUor/src.linux-i686-2.4/mebdfdaemodule.c:2186: 
error: `mas' undeclared (first use in this function)
/tmp/tmp9spUor/src.linux-i686-2.4/mebdfdaemodule.c:2189: 
error: `mas_nofargs' undeclared (first use in this 
function)
/tmp/tmp9spUor/src.linux-i686-2.4/mebdfdaemodule.c:2190: 
error: syntax error at '#' token
/tmp/tmp9spUor/src.linux-i686-2.4/mebdfdaemodule.c:2190: 
error: syntax error at '#' token
/tmp/tmp9spUor/src.linux-i686-2.4/mebdfdaemodule.c:2190: 
error: syntax error at '#' token
/tmp/tmp9spUor/src.linux-i686-2.4/mebdfdaemodule.c:2190: 
error: syntax error at '#' token
/tmp/tmp9spUor/src.linux-i686-2.4/mebdfdaemodule.c:2201: 
error: `f_cptr' undeclared (first use in this function)
/tmp/tmp9spUor/src.linux-i686-2.4/mebdfdaemodule.c:2203: 
error: `f' undeclared (first use in this function)
/tmp/tmp9spUor/src.linux-i686-2.4/mebdfdaemodule.c:2206: 
error: `f_nofargs' undeclared (first use in this function)
/tmp/tmp9spUor/src.linux-i686-2.4/mebdfdaemodule.c:2207: 
error: syntax error at '#' token
/tmp/tmp9spUor/src.linux-i686-2.4/mebdfdaemodule.c:2207: 
error: syntax error at '#' token
/tmp/tmp9spUor/src.linux-i686-2.4/mebdfdaemodule.c:2207: 
error: syntax error at '#' token
/tmp/tmp9spUor/src.linux-i686-2.4/mebdfdaemodule.c:2207: 
error: syntax error at '#' token
/tmp/tmp9spUor/src.linux-i686-2.4/mebdfdaemodule.c: In 
function `f2py_rout_mebdfdae_pset':
/tmp/tmp9spUor/src.linux-i686-2.4/mebdfdaemodule.c:3027: 
error: `mas_typedef' undeclared (first use in this 
function)
/tmp/tmp9spUor/src.linux-i686-2.4/mebdfdaemodule.c:3027: 
error: syntax error before "mas_cptr"
/tmp/tmp9spUor/src.linux-i686-2.4/mebdfdaemodule.c:3228: 
error: `mas_cptr' undeclared (first use in this function)
/tmp/tmp9spUor/src.linux-i686-2.4/mebdfdaemodule.c:3230: 
error: `mas' undeclared (first use in this function)
/tmp/tmp9spUor/src.linux-i686-2.4/mebdfdaemodule.c:3233: 
error: `mas_nofargs' undeclared (first use in this 
function)
/tmp/tmp9spUor/src.linux-i686-2.4/mebdfdaemodule.c:3234: 
error: syntax error at '#' token
/tmp/tmp9spUor/src.linux-i686-2.4/mebdfdaemodule.c:3234: 
error: syntax error at '#' token
/tmp/tmp9spUor/src.linux-i686-2.4/mebdfdaemodule.c:3234: 
error: `maxnofargs' undeclared (first use in this 
function)
/tmp/tmp9spUor/src.linux-i686-2.4/mebdfdaemodule.c:3234: 
error: syntax error at '#' token
/tmp/tmp9spUor/src.linux-i686-2.4/mebdfdaemodule.c:3234: 
error: syntax error at '#' token
/tmp/tmp9spUor/src.linux-i686-2.4/mebdfdaemodule.c:3234: 
error: `nofoptargs' undeclared (first use in this 
function)
/tmp/tmp9spUor/src.linux-i686-2.4/mebdfdaemodule.c: In 
function `f2py_rout_mebdfdae_stiff':
/tmp/tmp9spUor/src.linux-i686-2.4/mebdfdaemodule.c:5829: 
error: `pderv_typedef' undeclared (first use in this 
function)
/tmp/tmp9spUor/src.linux-i686-2.4/mebdfdaemodule.c:5829: 
error: syntax error before "pderv_cptr"
/tmp/tmp9spUor/src.linux-i686-2.4/mebdfdaemodule.c:5920: 
error: `pderv_cptr' undeclared (first use in this 
function)
/tmp/tmp9spUor/src.linux-i686-2.4/mebdfdaemodule.c:5922: 
error: `pderv' undeclared (first use in this function)
/tmp/tmp9spUor/src.linux-i686-2.4/mebdfdaemodule.c:5925: 
error: `pderv_nofargs' undeclared (first use in this 
function)
/tmp/tmp9spUor/src.linux-i686-2.4/mebdfdaemodule.c:5926: 
error: syntax error at '#' token
/tmp/tmp9spUor/src.linux-i686-2.4/mebdfdaemodule.c:5926: 
error: syntax error at '#' token
/tmp/tmp9spUor/src.linux-i686-2.4/mebdfdaemodule.c:5926: 
error: `maxnofargs' undeclared (first use in this 
function)
/tmp/tmp9spUor/src.linux-i686-2.4/mebdfdaemodule.c:5926: 
error: syntax error at '#' token
/tmp/tmp9spUor/src.linux-i686-2.4/mebdfdaemodule.c:5926: 
error: syntax error at '#' token
/tmp/tmp9spUor/src.linux-i686-2.4/mebdfdaemodule.c:5926: 
error: `nofoptargs' undeclared (first use in this 
function)
/tmp/tmp9spUor/src.linux-i686-2.4/mebdfdaemodule.c:599: 
error: redefinition of `n_cb_capi'
/tmp/tmp9spUor/src.linux-i686-2.4/mebdfdaemodule.c:599: 
error: `n_cb_capi' previously declared here
/tmp/tmp9spUor/src.linux-i686-2.4/mebdfdaemodule.c: In 
function `cb_pderv_in_pset__user__routines':
/tmp/tmp9spUor/src.linux-i686-2.4/mebdfdaemodule.c:599: 
error: redeclaration of `n_cb_capi'
/tmp/tmp9spUor/src.linux-i686-2.4/mebdfdaemodule.c:599: 
error: `n_cb_capi' previously declared here
/tmp/tmp9spUor/src.linux-i686-2.4/mebdfdaemodule.c:608: 
error: redeclaration of `n'
/tmp/tmp9spUor/src.linux-i686-2.4/mebdfdaemodule.c:607: 
error: `n' previously declared here
/tmp/tmp9spUor/src.linux-i686-2.4/mebdfdaemodule.c:607: 
warning: unused variable `n'
/tmp/tmp9spUor/src.linux-i686-2.4/mebdfdaemodule.c: In 
function `f2py_rout_mebdfdae_mebdf':
/tmp/tmp9spUor/src.linux-i686-2.4/mebdfdaemodule.c:1467: 
error: `f_typedef' undeclared (first use in this function)
/tmp/tmp9spUor/src.linux-i686-2.4/mebdfdaemodule.c:1467: 
error: (Each undeclared identifier is reported only once
/tmp/tmp9spUor/src.linux-i686-2.4/mebdfdaemodule.c:1467: 
error: for each function it appears in.)
/tmp/tmp9spUor/src.linux-i686-2.4/mebdfdaemodule.c:1467: 
error: syntax error before "f_cptr"
/tmp/tmp9spUor/src.linux-i686-2.4/mebdfdaemodule.c:1472: 
error: `pderv_typedef' undeclared (first use in this 
function)
/tmp/tmp9spUor/src.linux-i686-2.4/mebdfdaemodule.c:1472: 
error: syntax error before "pderv_cptr"
/tmp/tmp9spUor/src.linux-i686-2.4/mebdfdaemodule.c:1477: 
error: `mas_typedef' undeclared (first use in this 
function)
/tmp/tmp9spUor/src.linux-i686-2.4/mebdfdaemodule.c:1477: 
error: syntax error before "mas_cptr"
/tmp/tmp9spUor/src.linux-i686-2.4/mebdfdaemodule.c:1555: 
error: `pderv_cptr' undeclared (first use in this 
function)
/tmp/tmp9spUor/src.linux-i686-2.4/mebdfdaemodule.c:1557: 
error: `pderv' undeclared (first use in this function)
/tmp/tmp9spUor/src.linux-i686-2.4/mebdfdaemodule.c:1560: 
error: `pderv_nofargs' undeclared (first use in this 
function)
/tmp/tmp9spUor/src.linux-i686-2.4/mebdfdaemodule.c:1561: 
error: syntax error at '#' token
/tmp/tmp9spUor/src.linux-i686-2.4/mebdfdaemodule.c:1561: 
error: syntax error at '#' token
/tmp/tmp9spUor/src.linux-i686-2.4/mebdfdaemodule.c:1561: 
error: `maxnofargs' undeclared (first use in this 
function)
/tmp/tmp9spUor/src.linux-i686-2.4/mebdfdaemodule.c:1561: 
error: syntax error at '#' token
/tmp/tmp9spUor/src.linux-i686-2.4/mebdfdaemodule.c:1561: 
error: syntax error at '#' token
/tmp/tmp9spUor/src.linux-i686-2.4/mebdfdaemodule.c:1561: 
error: `nofoptargs' undeclared (first use in this 
function)
/tmp/tmp9spUor/src.linux-i686-2.4/mebdfdaemodule.c:1572: 
error: `mas_cptr' undeclared (first use in this function)
/tmp/tmp9spUor/src.linux-i686-2.4/mebdfdaemodule.c:1574: 
error: `mas' undeclared (first use in this function)
/tmp/tmp9spUor/src.linux-i686-2.4/mebdfdaemodule.c:1577: 
error: `mas_nofargs' undeclared (first use in this 
function)
/tmp/tmp9spUor/src.linux-i686-2.4/mebdfdaemodule.c:1578: 
error: syntax error at '#' token
/tmp/tmp9spUor/src.linux-i686-2.4/mebdfdaemodule.c:1578: 
error: syntax error at '#' token
/tmp/tmp9spUor/src.linux-i686-2.4/mebdfdaemodule.c:1578: 
error: syntax error at '#' token
/tmp/tmp9spUor/src.linux-i686-2.4/mebdfdaemodule.c:1578: 
error: syntax error at '#' token
/tmp/tmp9spUor/src.linux-i686-2.4/mebdfdaemodule.c:1612: 
error: `f_cptr' undeclared (first use in this function)
/tmp/tmp9spUor/src.linux-i686-2.4/mebdfdaemodule.c:1614: 
error: `f' undeclared (first use in this function)
/tmp/tmp9spUor/src.linux-i686-2.4/mebdfdaemodule.c:1617: 
error: `f_nofargs' undeclared (first use in this function)
/tmp/tmp9spUor/src.linux-i686-2.4/mebdfdaemodule.c:1618: 
error: syntax error at '#' token
/tmp/tmp9spUor/src.linux-i686-2.4/mebdfdaemodule.c:1618: 
error: syntax error at '#' token
/tmp/tmp9spUor/src.linux-i686-2.4/mebdfdaemodule.c:1618: 
error: syntax error at '#' token
/tmp/tmp9spUor/src.linux-i686-2.4/mebdfdaemodule.c:1618: 
error: syntax error at '#' token
/tmp/tmp9spUor/src.linux-i686-2.4/mebdfdaemodule.c: In 
function `f2py_rout_mebdfdae_ovdriv':
/tmp/tmp9spUor/src.linux-i686-2.4/mebdfdaemodule.c:2020: 
error: `f_typedef' undeclared (first use in this function)
/tmp/tmp9spUor/src.linux-i686-2.4/mebdfdaemodule.c:2020: 
error: syntax error before "f_cptr"
/tmp/tmp9spUor/src.linux-i686-2.4/mebdfdaemodule.c:2025: 
error: `pderv_typedef' undeclared (first use in this 
function)
/tmp/tmp9spUor/src.linux-i686-2.4/mebdfdaemodule.c:2025: 
error: syntax error before "pderv_cptr"
/tmp/tmp9spUor/src.linux-i686-2.4/mebdfdaemodule.c:2030: 
error: `mas_typedef' undeclared (first use in this 
function)
/tmp/tmp9spUor/src.linux-i686-2.4/mebdfdaemodule.c:2030: 
error: syntax error before "mas_cptr"
/tmp/tmp9spUor/src.linux-i686-2.4/mebdfdaemodule.c:2164: 
error: `pderv_cptr' undeclared (first use in this 
function)
/tmp/tmp9spUor/src.linux-i686-2.4/mebdfdaemodule.c:2166: 
error: `pderv' undeclared (first use in this function)
/tmp/tmp9spUor/src.linux-i686-2.4/mebdfdaemodule.c:2169: 
error: `pderv_nofargs' undeclared (first use in this 
function)
/tmp/tmp9spUor/src.linux-i686-2.4/mebdfdaemodule.c:2170: 
error: syntax error at '#' token
/tmp/tmp9spUor/src.linux-i686-2.4/mebdfdaemodule.c:2170: 
error: syntax error at '#' token
/tmp/tmp9spUor/src.linux-i686-2.4/mebdfdaemodule.c:2170: 
error: `maxnofargs' undeclared (first use in this 
function)
/tmp/tmp9spUor/src.linux-i686-2.4/mebdfdaemodule.c:2170: 
error: syntax error at '#' token
/tmp/tmp9spUor/src.linux-i686-2.4/mebdfdaemodule.c:2170: 
error: syntax error at '#' token
/tmp/tmp9spUor/src.linux-i686-2.4/mebdfdaemodule.c:2170: 
error: `nofoptargs' undeclared (first use in this 
function)
/tmp/tmp9spUor/src.linux-i686-2.4/mebdfdaemodule.c:2184: 
error: `mas_cptr' undeclared (first use in this function)
/tmp/tmp9spUor/src.linux-i686-2.4/mebdfdaemodule.c:2186: 
error: `mas' undeclared (first use in this function)
/tmp/tmp9spUor/src.linux-i686-2.4/mebdfdaemodule.c:2189: 
error: `mas_nofargs' undeclared (first use in this 
function)
/tmp/tmp9spUor/src.linux-i686-2.4/mebdfdaemodule.c:2190: 
error: syntax error at '#' token
/tmp/tmp9spUor/src.linux-i686-2.4/mebdfdaemodule.c:2190: 
error: syntax error at '#' token
/tmp/tmp9spUor/src.linux-i686-2.4/mebdfdaemodule.c:2190: 
error: syntax error at '#' token
/tmp/tmp9spUor/src.linux-i686-2.4/mebdfdaemodule.c:2190: 
error: syntax error at '#' token
/tmp/tmp9spUor/src.linux-i686-2.4/mebdfdaemodule.c:2201: 
error: `f_cptr' undeclared (first use in this function)
/tmp/tmp9spUor/src.linux-i686-2.4/mebdfdaemodule.c:2203: 
error: `f' undeclared (first use in this function)
/tmp/tmp9spUor/src.linux-i686-2.4/mebdfdaemodule.c:2206: 
error: `f_nofargs' undeclared (first use in this function)
/tmp/tmp9spUor/src.linux-i686-2.4/mebdfdaemodule.c:2207: 
error: syntax error at '#' token
/tmp/tmp9spUor/src.linux-i686-2.4/mebdfdaemodule.c:2207: 
error: syntax error at '#' token
/tmp/tmp9spUor/src.linux-i686-2.4/mebdfdaemodule.c:2207: 
error: syntax error at '#' token
/tmp/tmp9spUor/src.linux-i686-2.4/mebdfdaemodule.c:2207: 
error: syntax error at '#' token
/tmp/tmp9spUor/src.linux-i686-2.4/mebdfdaemodule.c: In 
function `f2py_rout_mebdfdae_pset':
/tmp/tmp9spUor/src.linux-i686-2.4/mebdfdaemodule.c:3027: 
error: `mas_typedef' undeclared (first use in this 
function)
/tmp/tmp9spUor/src.linux-i686-2.4/mebdfdaemodule.c:3027: 
error: syntax error before "mas_cptr"
/tmp/tmp9spUor/src.linux-i686-2.4/mebdfdaemodule.c:3228: 
error: `mas_cptr' undeclared (first use in this function)
/tmp/tmp9spUor/src.linux-i686-2.4/mebdfdaemodule.c:3230: 
error: `mas' undeclared (first use in this function)
/tmp/tmp9spUor/src.linux-i686-2.4/mebdfdaemodule.c:3233: 
error: `mas_nofargs' undeclared (first use in this 
function)
/tmp/tmp9spUor/src.linux-i686-2.4/mebdfdaemodule.c:3234: 
error: syntax error at '#' token
/tmp/tmp9spUor/src.linux-i686-2.4/mebdfdaemodule.c:3234: 
error: syntax error at '#' token
/tmp/tmp9spUor/src.linux-i686-2.4/mebdfdaemodule.c:3234: 
error: `maxnofargs' undeclared (first use in this 
function)
/tmp/tmp9spUor/src.linux-i686-2.4/mebdfdaemodule.c:3234: 
error: syntax error at '#' token
/tmp/tmp9spUor/src.linux-i686-2.4/mebdfdaemodule.c:3234: 
error: syntax error at '#' token
/tmp/tmp9spUor/src.linux-i686-2.4/mebdfdaemodule.c:3234: 
error: `nofoptargs' undeclared (first use in this 
function)
/tmp/tmp9spUor/src.linux-i686-2.4/mebdfdaemodule.c: In 
function `f2py_rout_mebdfdae_stiff':
/tmp/tmp9spUor/src.linux-i686-2.4/mebdfdaemodule.c:5829: 
error: `pderv_typedef' undeclared (first use in this 
function)
/tmp/tmp9spUor/src.linux-i686-2.4/mebdfdaemodule.c:5829: 
error: syntax error before "pderv_cptr"
/tmp/tmp9spUor/src.linux-i686-2.4/mebdfdaemodule.c:5920: 
error: `pderv_cptr' undeclared (first use in this 
function)
/tmp/tmp9spUor/src.linux-i686-2.4/mebdfdaemodule.c:5922: 
error: `pderv' undeclared (first use in this function)
/tmp/tmp9spUor/src.linux-i686-2.4/mebdfdaemodule.c:5925: 
error: `pderv_nofargs' undeclared (first use in this 
function)
/tmp/tmp9spUor/src.linux-i686-2.4/mebdfdaemodule.c:5926: 
error: syntax error at '#' token
/tmp/tmp9spUor/src.linux-i686-2.4/mebdfdaemodule.c:5926: 
error: syntax error at '#' token
/tmp/tmp9spUor/src.linux-i686-2.4/mebdfdaemodule.c:5926: 
error: `maxnofargs' undeclared (first use in this 
function)
/tmp/tmp9spUor/src.linux-i686-2.4/mebdfdaemodule.c:5926: 
error: syntax error at '#' token
/tmp/tmp9spUor/src.linux-i686-2.4/mebdfdaemodule.c:5926: 
error: syntax error at '#' token
/tmp/tmp9spUor/src.linux-i686-2.4/mebdfdaemodule.c:5926: 
error: `nofoptargs' undeclared (first use in this 
function)
error: Command "gcc -pthread -fno-strict-aliasing -DNDEBUG 
-O2 -march=i586 -mcpu=i686 -fmessage-length=0 -Wall -g 
-fPIC -I/tmp/tmp9spUor/src.linux-i686-2.4 
-I/usr/lib/python2.4/site-packages/numpy/core/include 
-I/usr/include/python2.4 -c 
/tmp/tmp9spUor/src.linux-i686-2.4/mebdfdaemodule.c -o 
/tmp/tmp9spUor/tmp/tmp9spUor/src.linux-i686-2.4/mebdfdaemodule.o" 
failed with exit status 1

How can I fix this problem ?

Nils



More information about the SciPy-User mailing list