Closed narinluangrath closed 8 years ago
@narinluangrath You need to install lapack/blas. Just google for installing them. Should work fine after that.
@narinluangrath Apart from what @ankurankan mentioned, you have installed dependencies for python2.7 in your conda env, create a new env for python3 and install dependencies in it. Things will be much more hassle free this way.
Hi @khalibartan,
I installed lapack/blas and I created a new environment and installed the dependencies using
$ conda create -n pgmpy-env python=3.4
$ source activate pgmpy-env
$ conda install --file requirements.txt
But when I try installing again I get a new error:
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-x86_64-3.4/scipy/optimize/lbfgsb/_lbfgsbmodule.c"
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-x86_64-3.4/scipy/optimize/cobyla/_cobylamodule.c"
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-x86_64-3.4/scipy/optimize/minpack2/minpack2module.c"
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-x86_64-3.4/scipy/optimize/slsqp/_slsqpmodule.c"
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-x86_64-3.4/scipy/optimize/nnls/_nnlsmodule.c"
Reading fortran codes...
Reading file 'build/src.linux-x86_64-3.4/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-x86_64-3.4/build/src.linux-x86_64-3.4/scipy/sparse/linalg/isolve/iterative/_iterativemodule.c"
Reading fortran codes...
Reading file 'build/src.linux-x86_64-3.4/scipy/sparse/linalg/eigen/arpack/arpack.pyf' (format:free)
Line #5 in build/src.linux-x86_64-3.4/scipy/sparse/linalg/eigen/arpack/arpack.pyf:" <_rd=real,double precision>"
crackline:1: No pattern for line
Line #6 in build/src.linux-x86_64-3.4/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 "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
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
Wrote C/API module "_arpack" to file "build/src.linux-x86_64-3.4/build/src.linux-x86_64-3.4/scipy/sparse/linalg/eigen/arpack/_arpackmodule.c"
Fortran 77 wrappers are saved to "build/src.linux-x86_64-3.4/build/src.linux-x86_64-3.4/scipy/sparse/linalg/eigen/arpack/_arpack-f2pywrappers.f"
[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'
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: csphjy
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: sphi
Block: rcty
Block: lpni
Block: cyzo
Block: csphik
Block: sphj
Block: othpl
Block: klvnzo
Block: jyzo
Block: rctj
Block: herzo
Block: sphk
Block: pbvv
Block: segv
Block: sphy
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 "csphjy"...
nm,csj,cdj,csy,cdy = csphjy(n,z)
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 "sphi"...
nm,si,di = sphi(n,x)
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 "csphik"...
nm,csi,cdi,csk,cdk = csphik(n,z)
Constructing wrapper function "sphj"...
nm,sj,dj = sphj(n,x)
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 "sphk"...
nm,sk,dk = sphk(n,x)
Constructing wrapper function "pbvv"...
vv,vp,pvf,pvd = pbvv(v,x)
Constructing wrapper function "segv"...
cv,eg = segv(m,n,c,kd)
Constructing wrapper function "sphy"...
nm,sy,dy = sphy(n,x)
Wrote C/API module "specfun" to file "build/src.linux-x86_64-3.4/scipy/special/specfunmodule.c"
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-x86_64-3.4/scipy/stats/statlibmodule.c"
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-x86_64-3.4/scipy/stats/mvnmodule.c"
Fortran 77 wrappers are saved to "build/src.linux-x86_64-3.4/scipy/stats/mvn-f2pywrappers.f"
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'
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
Could not locate executable gfortran
Could not locate executable f95
Could not locate executable ifort
Could not locate executable ifc
Could not locate executable lf95
Could not locate executable pgfortran
Could not locate executable f90
Could not locate executable f77
Could not locate executable fort
Could not locate executable efort
Could not locate executable efc
Could not locate executable g77
Could not locate executable g95
Could not locate executable pathf95
don't know how to compile Fortran code on platform 'posix'
error: Setup script exited with error: library dfftpack has Fortran sources but no Fortran compiler found
(pgmpy-env)narin@narin-HP-G60-Notebook-PC:~/pgmpy$
I'm running into errors installing pgmpy and unfortunately I don't have enough technical knowledge to understand what they mean. Below is the output from the terminal when I follow the installation guide on https://github.com/pgmpy/pgmpy