diff -Nru munipack-0.5.9/artificial/artest.sh munipack-0.5.10/artificial/artest.sh --- munipack-0.5.9/artificial/artest.sh 2017-07-17 23:03:48.000000000 +0000 +++ munipack-0.5.10/artificial/artest.sh 2018-01-16 17:58:03.000000000 +0000 @@ -2,35 +2,77 @@ # A variable star RA=150 DEC=50 -LCID="--lc-model Cepheid" +JD0=2457948.5 LCID="--lc-fourier fourier.fits" LCID="--lc-table Kepler-21b.fits" -munipack artificial --verbose --mask 'art_??.fits' --fov 0.3 --rcen $RA --dcen $DEC \ - --date 2017-07-14 --time 00:00:00 --count 48 --timestep 180 --exptime 60 \ - $LCID --lc-mag 12 --lc-amp 1 --lc-jd0 2457948.5 --lc-per 0.1 \ - --lc-ra $RA --lc-dec $DEC +LCID="--lc-model Cepheid" +munipack artificial --verbose --mask 'art_??.fits' --fov 0.3 --count 48 \ + --rcen $RA --dcen $DEC \ + --lc-ra $RA --lc-dec $DEC \ + $LCID --lc-mag 12 --lc-amp 1 --lc-jd0 $JD0 --lc-per 0.1 \ + --date 2017-07-14 --time 00:00:00 --timestep 180 --exptime 90 LS="art_??.fits" munipack find $LS munipack aphot $LS -munipack phcal -C 1 --photsys-ref Johnson -f V -O --mask '\!\1_man.\2' art_01.fits +cp art_01.fits art_01_grow.fits +munipack gphot art_01_grow.fits + +# aperture correction +R90=$(munipack fits --shell -K RADFLX90 art_01_grow.fits\[GROWPHOT\] | \ + awk -F '=' '{print $2;}') +BEGIN='BEGIN { q = -1; }' +BODY='{if($0~/^APER/ && $2 >= r && q < 0) {q=$2;gsub("APER","",$1);print $1;}}' +SAPER=$(munipack fits -lh art_01_grow.fits\[APERPHOT\] | \ + awk -F '[=/]' -v r=$R90 "$BEGIN $BODY") +APCORR=$(munipack fits -lt art_01_grow.fits\[GROWCURVE\] | \ + awk -v saper=$SAPER '{if( NR == saper ) print 1/$2;}') + +munipack phcal -C 1 --saper $SAPER --photsys-ref Johnson -f V \ + art_01_grow.fits,man_01.fits for A in $LS; do - munipack phcal --photsys-ref Johnson -f V -r art_01_man.fits $A; + munipack phcal --photsys-ref Johnson -f V -r man_01.fits \ + --apcorr $APCORR --saper $SAPER $A; done -munipack timeseries -c MAG,MAGERR --stdout ${RA},${DEC} art_*_cal.fits > Kepler-21b.lc +echo "# JD MAG " > lc +munipack timeseries -c MAG,MAGERR --stdout ${RA},${DEC} art_*_cal.fits >> lc -munipack fits -lt Kepler-21b.fits | awk '{print 0.5+0.1*$1, 12-1.086*log($2)}' > lcmodel +echo "# JD MAG " > lcmodel +BEGIN='BEGIN { JD=0; MAG=99.999; }' +BODY='{ if($0~/^JD/) JD=$2; if($0~/current magnitude/) MAG=$2; }' +END='END {print JD MAG;}' +for A in $LS; do + munipack fits -lh $A | awk -F '[=/]' "$BEGIN $BODY $END" >> lcmodel +done + +paste lc lcmodel > lcd gnuplot <> ext_G munipack fits -lt ${A%_catcal.fits}.fits\[GROWCURVE\] > $D diff -Nru munipack-0.5.9/artificial/artificial.f95 munipack-0.5.10/artificial/artificial.f95 --- munipack-0.5.9/artificial/artificial.f95 2017-07-17 23:03:48.000000000 +0000 +++ munipack-0.5.10/artificial/artificial.f95 2018-01-16 17:58:03.000000000 +0000 @@ -20,6 +20,10 @@ ! ! ! * The variable star part, implemented as a class, would by more classy. +! * Checking proper combination of parameters during computations (to prevent +! frames below horizon with athmosphere, negative values of radiuses, etc.)? +! * Add galaxies (pofiles as NFW, Hubble, King, spirals) or globular clusters +! with Plummer? Fractals for nebuale? ! program artificial @@ -37,26 +41,27 @@ real(dbl), parameter :: j2000 = 2451544.5_dbl character(len=4*FLEN_FILENAME) :: record,key,val,fmt - character(len=FLEN_FILENAME) :: cat = '', phsystable = '', phsystem = 'Johnson', & - file = 'artificial.fits', filemask = 'artificial_???.fits' + character(len=FLEN_FILENAME) :: cat = '', phsystable = '', & + phsystem = 'Johnson', file = 'artificial.fits', & + filemask = 'artificial_???.fits' logical :: verbose = .false., plog = .false. integer, dimension(2) :: naxes = (/ 666, 666 /) real(dbl), dimension(2) :: crpix = (/333, 333/) integer :: bitpix = -32 integer :: nfiles = 0 integer :: eq,n,i,l1,l2 - real(dbl) :: blevel = 1000, bnoise = -1 - real(dbl), dimension(2) :: bgrad = (/0, 0/) + real(dbl) :: skymag = 21 ! mag per 1 sq. arcsec + real(dbl), dimension(2) :: skygrad = (/0,0/) ! mag per 1 sq. arcsec per pix integer :: maglim = 13 - real(dbl) :: exptime = 1, area = 1 ! 1 sec per 1 sq.meter, equivalent r=0.56m + real(dbl) :: exptime = 1, area = 1 ! 1 sec per 1 sq.meter, equiv. r=0.56m real(dbl) :: hwhm = 1 ! in pixels - real(dbl) :: airy = 0.1 ! Airy disk radius in pixels for r=0.56m + real(dbl) :: airy = 0.1 ! Airy disk radius in pix for r=0.56m real(dbl) :: beta = 2 ! Moffat exponent real(dbl) :: scale = 1.0 / 3600.0 ! 1 arcsex = 1 pix - real(dbl) :: fov = 666. / 3600.0 ! field of view, used for scale setup only + real(dbl) :: fov = 666. / 3600.0 ! field of view, used for scale setup real(dbl) :: angle = 0 real(dbl) :: qefficiency = 1 - real(dbl) :: extink = 0 ! extinction coefficient + real(dbl) :: extink = 0.1 ! extinction coefficient real(dbl) :: longitude = 0 ! geographic longitude real(dbl) :: latitude = 0 ! geographic latitude real(dbl) :: timestep = 60 ! time step in seconds @@ -64,8 +69,8 @@ real(dbl) :: year = 2000, month = 1, day = 1, hour = 0, min = 0, sec = 0, r, d real(dbl), dimension(2) :: crval = 0 real(dbl) :: lcmag = 15 ! lc magnitude - real(dbl) :: lcamp = 0.4 ! lc amplitude - real(dbl) :: mamp = 1 ! lc amplitude in magnitudes + real(dbl) :: ccmag = 15 ! current magnitude + real(dbl) :: lcamp = 1 ! lc amplitude real(dbl) :: lcjd0 = j2000 ! lc reference time real(dbl) :: lcper = 1 ! lc period real(dbl), dimension(2) :: lcoo = 0 ! lc coordinates @@ -76,8 +81,8 @@ character(len=FLEN_VALUE) :: lcmodel = '', lctable = '', lcfourier = '' complex(dbl), dimension(:), allocatable :: fcoeff ! lc Fourier coefficients real(dbl), dimension(:), allocatable :: xcoo,ycoo,flux - ! 'FFT' for FFT convolution, 'RANDOM' for random offset, 'AUTO' for 'RANDOM' of short - ! exposures and 'TEST' for direct convolution + ! 'FFT' for FFT convolution, 'RANDOM' for random offset, 'AUTO' for 'RANDOM' + ! of short exposures and 'TEST' for direct convolution logical :: atmosphere = .false. logical :: lcmode = .false. logical :: datetime_init = .false. @@ -115,21 +120,17 @@ read(val,*) bitpix - else if( key == 'BLEVEL' ) then + else if( key == 'SKYMAG' ) then - read(val,*) blevel + read(val,*) skymag - else if( key == 'BNOISE' ) then + else if( key == 'SKYGRADX' ) then - read(val,*) bnoise + read(val,*) skygrad(1) - else if( key == 'BGRADX' ) then + else if( key == 'SKYGRADY' ) then - read(val,*) bgrad(1) - - else if( key == 'BGRADY' ) then - - read(val,*) bgrad(2) + read(val,*) skygrad(2) else if( key == 'MAGLIM' ) then @@ -263,7 +264,7 @@ else if( key == 'LCAMP' ) then - read(val,*) mamp + read(val,*) lcamp else if( key == 'LCJD0' ) then @@ -302,9 +303,6 @@ end if end if - ! setup noise by Poisson - if( bnoise < 0 .and. blevel > 0 ) bnoise = sqrt(blevel) - ! whatever LC is generated if( lcmodel /= '' .or. lctable /= '' .or. lcfourier /= '' ) lcmode = .true. @@ -318,7 +316,6 @@ call lcfourio(lcfourier,fcoeff) end if - lcamp = 10**(0.4*mamp) end if ! stars @@ -348,9 +345,9 @@ end if write(error_unit,*) "Photometry system: ",trim(phsystem) write(error_unit,*) "Filter: ",trim(filter) - write(error_unit,'(a,f0.1)') " Background level = ",blevel - write(error_unit,'(a,f0.1)') " Background noise = ",bnoise - write(error_unit,'(a,2(f0.1,2x))') " Background gradient = ",bgrad + write(error_unit,'(a,f0.1,a)') " Sky magnitude = ",skymag," mag/arcsec2" + write(error_unit,'(a,2(g0.2,2x),a)') & + " Sky gradient = ",skygrad," mag/arcsec2/pix" write(error_unit,'(a,f0.2,a)') " Area = ",area," [m2]" write(error_unit,'(a,f0.1,a)') " Exposure time = ",exptime," [s]" write(error_unit,'(a,f0.1,a)') " Time span = ",timestep," [s]" @@ -382,17 +379,20 @@ write(error_unit,*) "Light curve by Fourier coefficients in: `", & trim(lcfourier),"':" do i = 0,size(fcoeff)-1 - write(error_unit,'(a,i0,a,2(3x,f0.5),a)') " c(",i,") = ",fcoeff(i),"i" + write(error_unit,'(a,i0,a,2(3x,f0.5),a)') " c(",i,") = ",& + fcoeff(i),"i" end do end if write(error_unit,'(a,f0.1)') " Light curve mean magnitude = ",lcmag write(error_unit,'(a,f0.1)') " Light curve amplitude = ",lcamp write(error_unit,'(a,f0.6)') " Light curve JD0 = ",lcjd0 - write(error_unit,'(a,f0.6,a)') " Light curve period = ",lcper," [day(s)]" - write(error_unit,'(a,2f7.2,a)') " Coordinates of the object: ",lcoo," [deg]" + write(error_unit,'(a,f0.6,a)') " Light curve period = ",lcper, & + " [day(s)]" + write(error_unit,'(a,2f7.2,a)') " Coordinates of the object: ",lcoo, & + " [deg]" end if write(error_unit,*) - write(error_unit,*) "Filename, JD, airmass, seeing radius:" + write(error_unit,*) "Filename, JD(begin), airmass, seeing radius:" end if @@ -405,8 +405,9 @@ if( nfiles == 0 .and. n == 0 ) file = filemask write(fmt,'(a,i0,a)') '(a,i0.',n,',a)' - if( datetime_init ) jd = datjd(year,month,day + (hour + (min + sec/60)/60)/24) - timestep = timestep / 86400 + if( datetime_init ) & + jd = datjd(year,month,day + (hour+(min+sec/60.0_dbl)/60.0_dbl)/24.0_dbl) + timestep = timestep / 86400.0_dbl if( nfiles == 0 ) then @@ -458,12 +459,18 @@ character(len=FLEN_COMMENT) :: com character(len=FLEN_VALUE) :: datetime real(dbl), dimension(:,:), allocatable :: sky - real(dbl) :: c,s,x,qe,see,extin,hwhms,jd2, ms, lcflux, phi + real(dbl) :: c,s,x,qe,see,extin,hwhms,jd2, ms, lcflux, phi, mag, back + real(dbl), dimension(2) :: bgrad integer :: year, month, day, hour, min, sec, m integer, dimension(2) :: maxes real(dbl), dimension(:), allocatable :: xstar,ystar,fluxes,xvar, yvar, fvar type(SprayType) :: spsf + ! background at zenit + back = magiconv(phsystable,phsystem,filter,(/skymag/)) + back = back * exptime * area * qefficiency * (scale*3600)**2 + bgrad = 1.086 * skygrad * back + if( atmosphere ) then ! compute airmass @@ -482,12 +489,16 @@ qe = extin * qefficiency ! http://www.astro.auth.gr/~seeing-gr/seeing_gr_files/theory/node17.html - ! Fries parameter + ! Fries parameter for spread see = x**0.6 hwhms = hwhm*see - if( verbose ) & - write(error_unit,'(a,f15.5,f8.3,2f6.2)') trim(filename),jd,x,extin,see + ! sky increases by airmass + back = back * extin + bgrad = 1.086 * skygrad * back + + if( verbose ) write(error_unit,'(a,f15.5,f8.3,2f6.2)') & + trim(filename),jd,x,extin,see else hwhms = hwhm qe = qefficiency @@ -501,38 +512,43 @@ phi = phase(jd,lcjd0,lcper) + lcflux = -1 + if( lcmodel == 'WAVE' ) then - lcflux = lcamp*wave(phi) + lcflux = wave(phi) else if( lcmodel == 'CEPHEID' ) then - lcflux = lcamp*delta_cep(phi) + lcflux = delta_cep(phi) else if( lcmodel == 'ALGOL' ) then - lcflux = lcamp*beta_per(phi) + lcflux = beta_per(phi) else if( lcmodel /= '' ) then - stop "Unrecognised light curve model. Try `Cepheid', `Algol' or `wave'." + stop "Unrecognised light curve model. Try `Cepheid', `Algol', `wave'." end if if( lcfourier /= '' ) then - lcflux = lcamp*fourfun(fcoeff,phi) + lcflux = fourfun(fcoeff,phi) end if if( lctable /= '' ) then lcflux = lcspline(phi) end if + if( lcflux < 0 ) stop 'Unspecified light curve model.' + allocate(xvar(1),yvar(1),fvar(1)) - call rain((/lcoo(1)/),(/lcoo(2)/),(/lcmag/),scale,angle,crval,crpix, & + mag = lcmag - (2.5_dbl*log10(lcamp*lcflux)) + call rain((/lcoo(1)/),(/lcoo(2)/),(/mag/),scale,angle,crval,crpix, & phsystable,phsystem,filter,xvar,yvar,fvar) - fvar = fvar * lcflux + ccmag = magconv(phsystable,phsystem,filter,fvar) else allocate(xvar(0),yvar(0),fvar(0)) end if + ! Frame generator allocate(sky(naxes(1),naxes(2))) sky = 0 - ! background - call background(blevel,bnoise,bgrad,sky) + call background(back,bgrad,sky) ! merge both lists: variables and ordinary stars m = size(xvar) @@ -552,7 +568,7 @@ call spreadstars(spsf,xstar,ystar,fluxes,sky) ! watermark - call watermark(sky,5*bnoise) + call watermark(sky,5*sqrt(back)) ! cleanup if( allocated(xvar) ) deallocate(xvar,yvar,fvar) @@ -573,14 +589,17 @@ ! extension with artifical frame call ftphps(15,bitpix,size(naxes),naxes,status) - write(datetime,"(i4.4,'-',i2.2,'-',i2.2,'T',i2.2,':',i2.2,':',i2.2,'.',i3.3)") & + write(datetime, & + "(i4.4,'-',i2.2,'-',i2.2,'T',i2.2,':',i2.2,':',i2.2,'.',i3.3)") & year, month, day, hour, min, sec, nint(ms) call ftpkys(15,FITS_KEY_DATEOBS,datetime,'date and time in UT',status) call ftpkys(15,FITS_KEY_FILTER,filter,'filter',status) - call ftpkyd(15,FITS_KEY_JD,jd2,-16,'[day] Julian date at half of exposure',status) + call ftpkyd(15,FITS_KEY_JD,jd2,-16,'[day] Julian date at half of exposure',& + status) call ftpkyd(15,FITS_KEY_EXPTIME,exptime,-3,'[s] exposure time',status) call ftpkyd(15,FITS_KEY_AREA,area,-2,'[m2] detection area',status) - call ftpkyd(15,FITS_KEY_HWHM,hwhms,-3,'[pix] half with at half maximum',status) + call ftpkyd(15,FITS_KEY_HWHM,hwhms,-3,'[pix] half with at half maximum',& + status) if( atmosphere ) & call ftpkyd(15,FITS_KEY_AIRMASS,x,-4,'airmass',status) call ftpkys(15,'PSF',psf,'PSF',status) @@ -590,8 +609,10 @@ call ftpkyd(15,'AIRYDISK',airy,-3,'[pix] Airy disk radius',status) call ftpkys(15,'SPREAD',spread,'seeing spread method ',status) end if - call ftpkys(15,'CTYPE1','RA---TAN','the coordinate type for the first axis',status) - call ftpkys(15,'CTYPE2','DEC--TAN','the coordinate type for the first axis',status) + call ftpkys(15,'CTYPE1','RA---TAN', & + 'the coordinate type for the first axis',status) + call ftpkys(15,'CTYPE2','DEC--TAN', & + 'the coordinate type for the second axis',status) call ftpkye(15,'CRPIX1',real(naxes(1)/2),-6,'[pix]',status) call ftpkye(15,'CRPIX2',real(naxes(2)/2),-6,'[pix]',status) call ftpkyd(15,'CRVAL1',crval(1),-17,'[deg]',status) @@ -602,12 +623,14 @@ call ftpkyd(15,'CD1_2',s*scale,13,'',status) call ftpkyd(15,'CD2_1',s*scale,13,'',status) call ftpkyd(15,'CD2_2',c*scale,13,'',status) - call ftpkyd(15,FITS_KEY_LONGITUDE,longitude,-5,'[deg] geographic longitude (-east)',status) - call ftpkyd(15,FITS_KEY_LATITUDE,latitude,-5,'[deg] geographic latitude (+north)',status) + call ftpkyd(15,FITS_KEY_LONGITUDE,longitude,-5, & + '[deg] geographic longitude (-east)',status) + call ftpkyd(15,FITS_KEY_LATITUDE,latitude,-5, & + '[deg] geographic latitude (+north)',status) call ftpcom(15,'Artificial sky by Munipack.',status) call ftpcom(15,'Parameters:',status) - write(com,'(a,4(g0.6,1x))') 'Background: level, noise, gradient = ',& - blevel,bnoise,bgrad + write(com,'(a,es10.3,1x,2(g0.2,1x))') & + 'Background: level, noise, gradient = ',back,bgrad call ftpcom(15,com,status) write(com,'(2a)') 'PSF = ',trim(psf) call ftpcom(15,com,status) @@ -623,6 +646,29 @@ write(com,'(a,g0.3)') 'Seeing factor = ', see call ftpcom(15,com,status) end if + if( lcmode ) then + write(com,'(2a)') 'Light curve model = ',trim(lcmodel) + call ftpcom(15,com,status) + if( lcfourier /= '' ) then + write(com,'(2a)') 'Fourier coefficients table = ', trim(lcfourier) + call ftpcom(15,com,status) + end if + if( lctable /= '' ) then + write(com,'(2a)') 'Spline interpolation table = ', trim(lctable) + call ftpcom(15,com,status) + end if + write(com,'(a,f0.3)') "Light curve current magnitude = ",ccmag + call ftpcom(15,com,status) + write(com,'(a,2(f0.3,1x))') & + "Light curve mean magnitude, amplitude = ",lcmag,lcamp + call ftpcom(15,com,status) + write(com,'(a,2(f0.6,1x),a)') & + "Light curve elements (JD0, period) = ",lcjd0,lcper," [day(s)]" + call ftpcom(15,com,status) + write(com,'(a,2(f0.5,1x),a)') & + "Light curve object coordinates = ",lcoo," [deg]" + call ftpcom(15,com,status) + end if call ftpcom(15,MUNIPACK_VERSION,status) call ftp2dd(15,1,naxes(1),naxes(1),naxes(2),sky,status) @@ -659,5 +705,40 @@ end subroutine lctable_init + function magconv(phsystable,phsystem,filter,ph) + + use phsysfits + use photoconv + + real(dbl) :: magconv + character(len=*), intent(in) :: filter, phsystable, phsystem + real(dbl), dimension(:), intent(in) :: ph + type(type_phsys) :: phsys + real(dbl), dimension(size(ph)) :: mag,dmag,dph + + call phselect(phsystable,phsystem,phsys) + dph = -1 + call phsysphmag1(phsys,filter,ph,dph,mag,dmag) + magconv = mag(1) + + end function magconv + + function magiconv(phsystable,phsystem,filter,mag) + + use phsysfits + use photoconv + + real(dbl) :: magiconv + character(len=*), intent(in) :: filter, phsystable, phsystem + real(dbl), dimension(:), intent(in) :: mag + type(type_phsys) :: phsys + real(dbl), dimension(size(mag)) :: ph,dph,dmag + + call phselect(phsystable,phsystem,phsys) + dmag = 9.999 + call phsysmagph1(phsys,filter,mag,dmag,ph,dph) + magiconv = ph(1) + + end function magiconv end program artificial diff -Nru munipack-0.5.9/artificial/generator.f95 munipack-0.5.10/artificial/generator.f95 --- munipack-0.5.9/artificial/generator.f95 2017-07-17 23:03:48.000000000 +0000 +++ munipack-0.5.10/artificial/generator.f95 2018-01-16 17:58:03.000000000 +0000 @@ -62,7 +62,8 @@ k = i - x do j = y - nw, y + nw l = j - y - if( 1 <= i .and. i <= naxes(1) .and. 1 <= j .and. j <= naxes(2) ) then + if( 1 <= i .and. i <= naxes(1) .and. & + 1 <= j .and. j <= naxes(2) ) then f = psf(k,l) if( f > 0 ) sky(i,j) = sky(i,j) + pnoise(f) end if @@ -75,8 +76,8 @@ end subroutine spreadstars - subroutine rain(alpha,delta,mag,scale,angle,crval,crpix,phsystable,phsystem,filter, & - xcoo,ycoo,flux) + subroutine rain(alpha,delta,mag,scale,angle,crval,crpix,phsystable, & + phsystem,filter,xcoo,ycoo,flux) use astrotrafo use phsysfits @@ -92,7 +93,8 @@ real(dbl), dimension(:), allocatable :: dmag, dflux integer :: n - call trafo_init(t,'GNOMONIC',crval(1),crval(2),crpix(1),crpix(2),scale=scale,rot=angle) + call trafo_init(t,'GNOMONIC',crval(1),crval(2),crpix(1),crpix(2),& + scale=scale,rot=angle) n = size(alpha) allocate(xcoo(n),ycoo(n),flux(n),dmag(n),dflux(n)) @@ -106,8 +108,8 @@ end subroutine rain - subroutine catstars(cat,labels,scale,angle,crval,crpix,phsystable,phsystem,filter, & - xcoo,ycoo,flux) + subroutine catstars(cat,labels,scale,angle,crval,crpix,phsystable, & + phsystem,filter,xcoo,ycoo,flux) use catio @@ -121,8 +123,8 @@ call catalogue(cat,labels,alpha,delta,mag,catid) - call rain(alpha,delta,mag,scale,angle,crval,crpix,phsystable,phsystem,filter, & - xcoo,ycoo,flux) + call rain(alpha,delta,mag,scale,angle,crval,crpix,phsystable, & + phsystem,filter,xcoo,ycoo,flux) deallocate(alpha,delta,mag) @@ -185,23 +187,24 @@ end subroutine stardist - subroutine background(blevel,bnoise,bgrad,sky) + subroutine background(b,bgrad,sky) use noise - real(dbl), intent(in) :: blevel,bnoise + real(dbl), intent(in) :: b real(dbl), dimension(:), intent(in) :: bgrad real(dbl), dimension(:,:), intent(out) :: sky integer :: i,j,ic,jc - real(dbl) :: dx,dy + real(dbl) :: db,dx,dy + db = sqrt(b) ic = size(sky,1) / 2 jc = size(sky,2) / 2 do i = 1,size(sky,1) dx = (i - ic)*bgrad(1) do j = 1,size(sky,2) dy = (j - jc)*bgrad(2) - sky(i,j) = gnoise(blevel + dx + dy,bnoise) + sky(i,j) = gnoise(b + dx + dy,db) end do end do diff -Nru munipack-0.5.9/artificial/lcapprox.f08 munipack-0.5.10/artificial/lcapprox.f08 --- munipack-0.5.9/artificial/lcapprox.f08 2017-07-17 23:03:48.000000000 +0000 +++ munipack-0.5.10/artificial/lcapprox.f08 2018-01-16 17:58:03.000000000 +0000 @@ -1,8 +1,8 @@ ! ! Light Curve Approximations by Fourier series ! -! gfortran -I../lib -Wall -g -p -fcheck=all -fimplicit-none -fbacktrace lcapprox.f08 \ -! -L../lib -lminpacks -lminpack +! gfortran -I../lib -Wall -g -p -fcheck=all -fimplicit-none -fbacktrace \ +! lcapprox.f08 -L../lib -lminpacks -lminpack ! ! Copyright © 2017 F.Hroch (hroch@physics.muni.cz) ! @@ -38,6 +38,7 @@ write(*,*) '! Copyright © 2017 F.Hroch (hroch@physics.muni.cz)' write(*,*) '!' write(*,*) '! This file is part of Munipack.' + write(*,*) '! All source code is generated by lcapprox.f08.' write(*,*) '!' write(*,*) '! Munipack is free software: you can redistribute it and/or modify' write(*,*) '! it under the terms of the GNU General Public License as published by' @@ -107,8 +108,8 @@ else tail = ' /)' end if - write(*,'(2(a,es22.15),2a)') ' cmplx(',real(dcep(i)),',',aimag(dcep(i)),& - ')',tail + write(*,'(2(a,es22.15),2a)') ' cmplx(',real(dcep(i)),',',& + aimag(dcep(i)),')',tail end do open(9,file='/tmp/dcep') @@ -197,7 +198,8 @@ else tail = ' /)' end if - write(*,'(2(a,es22.15),2a)') ' cmplx(',real(c(i)),',',aimag(c(i)),')',tail + write(*,'(2(a,es22.15),2a)') ' cmplx(',real(c(i)),',', & + aimag(c(i)),')',tail end do open(9,file='/tmp/algol') @@ -318,8 +320,8 @@ if( random ) then allocate(x(8),y(8)) - x = [ 0.0, 0.0, 1.0471975512, 1.0471975512, 1.570796326775, 3.14159265355, & - 3.14159265355, 4.712388980325] + x = [ 0.0, 0.0, 1.0471975512, 1.0471975512, 1.570796326775, & + 3.14159265355, 3.14159265355, 4.712388980325] y = [ 1.1, 0.8, 1.4, 1.6, 2.1, 2.8, 3.1, 2.1 ] cab = [ 2, -1,0,0] ! check: f(x) = 2 - cos(x) diff -Nru munipack-0.5.9/artificial/Makefile.in munipack-0.5.10/artificial/Makefile.in --- munipack-0.5.9/artificial/Makefile.in 2017-07-17 23:04:25.000000000 +0000 +++ munipack-0.5.10/artificial/Makefile.in 2018-01-16 17:58:14.000000000 +0000 @@ -270,7 +270,6 @@ builddir = @builddir@ datadir = @datadir@ datarootdir = @datarootdir@ -develop = @develop@ docdir = @docdir@ dvidir = @dvidir@ exec_prefix = @exec_prefix@ diff -Nru munipack-0.5.9/astrometry/absfit.f95 munipack-0.5.10/astrometry/absfit.f95 --- munipack-0.5.9/astrometry/absfit.f95 2017-07-17 23:03:48.000000000 +0000 +++ munipack-0.5.10/astrometry/absfit.f95 2018-01-16 17:58:03.000000000 +0000 @@ -2,7 +2,7 @@ ! absfit - fitting absolute deviations ! ! -! Copyright © 2011-2, 2015-6 F.Hroch (hroch@physics.muni.cz) +! Copyright © 2011-2, 2015-7 F.Hroch (hroch@physics.muni.cz) ! ! This file is part of Munipack. ! @@ -23,6 +23,7 @@ module absfit use astrotrafo + use iso_fortran_env implicit none @@ -74,25 +75,24 @@ real(dbl),intent(in) :: xrefl,xoff,dxoff,yoff,dyoff logical, intent(in) :: verbose - real(dbl), parameter :: eps = 1e3*epsilon(mad) real(dbl), parameter :: sqreps = sqrt(epsilon(mad)) real(dbl), parameter :: reqmin = epsilon(mad) integer, parameter :: npar = 4 real(dbl),dimension(npar) :: p,p0,dp ! = (x0, y0, sc, rot) - real(dbl) :: uu,vv + real(dbl) :: uu,vv,dd integer :: iter,icount, numres, ifault, i, nra, ndec type(AstroTrafoProj) :: t,ti - if( size(a) < 1 ) stop 'Absfit: no available stars.' + if( size(a) < 1 ) stop 'Absfit: no star available.' - if(verbose) write(*,*) "=== Absolute deviations fitting ===" + if(verbose) write(error_unit,*) "=== Absolute deviations fitting ===" debug = verbose xcen = xc ycen = yc - ! Important: x,y,u,v arrays are a common working places for both absmin and medfun !! + ! x,y,u,v arrays are a common working arrays for both absmin and medfun !! ndat = size(a) allocate(x(ndat),y(ndat),u(ndat),v(ndat)) @@ -105,25 +105,26 @@ call proj(t,a,d,u,v) p = (/xoff, yoff, sc, rot/) - dp = (/ dxoff, dyoff, dsc, drot/) + dd = 0.1*sc ! star centroids are usually located with the precision 0.1 pix + dp = (/ max(dxoff,dd), max(dyoff,dd), dsc, drot/) refl = xrefl - if( debug ) write(*,'(a)') & + if( debug ) write(error_unit,'(a)') & '# ifault mad acen dcen offset[pix] s[pix/deg] rot[deg]' - do iter = 1,13 + do iter = 1, precision(p) ! estimate transformation by minimizing of absolute deviations p0 = p dp = max(dp,sqreps) call nelmin(medfun,npar,p0,p,mad,reqmin,dp,1,9999,icount,numres,ifault) - ! the typical run needs about one thousand of medfun calls + ! a typical run needs about one thousand of medfun calls ! ifault=0 means convergence, 2 means slow convergence mad = mad / (2*ndat) - if( debug ) write(*,'(2i2,es10.2,2f11.5,2g11.2,f10.1,f7.1)') & + if( debug ) write(error_unit,'(2i2,es10.2,2f11.5,2g11.2,f10.1,f7.1)') & iter,ifault,mad,acen,dcen,p(1:2)/p(3),1/p(3),p(4) ! iterations couldn't make further progress, with precision 1/1000 [pix] @@ -133,7 +134,6 @@ call trafo_init(ti,type,acen=acen,dcen=dcen, & xcen=xcen,ycen=ycen,scale=p(3),rot=p(4),refl=refl) call invproj(ti,p(1),p(2),acen,dcen) -! write(*,'(6f12.5,2i5)') acen,dcen,t%acen,t%dcen,t%uv0,icount,numres call trafo_init(t,type,acen,dcen) call proj(t,a,d,u,v) p(1:2) = 0.0_dbl @@ -152,8 +152,10 @@ if( uu - u(i) > 0 ) nra = nra + 1 if( vv - v(i) > 0 ) ndec = ndec + 1 end do - write(*,'(a,3i7)') '# absfit sign test (total, positive ra,dec): ',ndat,nra,ndec - write(*,'(a,en12.2,en13.3,f8.1,2f11.5,f5.1)') & + write(error_unit,'(a,i7,"/",f0.1,2(i5,"+-",f0.1))') & + '# absfit sign test (total/expected, RA+, Dec+): ',& + ndat,ndat/2.0,nra,sqrt(nra*0.25),ndec,sqrt(ndec*0.25) + write(error_unit,'(a,en12.2,en13.3,f8.1,2f11.5,f5.1)') & "# absfit final:",mad,sc,rot,acen,dcen,refl end if diff -Nru munipack-0.5.9/astrometry/astrofit.f95 munipack-0.5.10/astrometry/astrofit.f95 --- munipack-0.5.9/astrometry/astrofit.f95 2017-07-17 23:03:48.000000000 +0000 +++ munipack-0.5.10/astrometry/astrofit.f95 2018-01-16 17:58:03.000000000 +0000 @@ -33,8 +33,8 @@ contains subroutine astrofit(fit,type,a,d,pma,pmd,x,y,sig,xsig,epoch,jd,xc,yc, & - acen,dacen,dcen,ddcen,sc,dsc,refl,rms,rot,drot,ares,dres,id1_init,id2_init, & - id1_final,id2_final,rmscheck,verb,pl) + acen,dacen,dcen,ddcen,sc,dsc,refl,rms,rot,drot,ares,dres, & + id1_init,id2_init,id1_final,id2_final,rmscheck,verb,pl) use absfit use robfit @@ -53,7 +53,7 @@ real(dbl), dimension(:), allocatable, intent(out) :: ares, dres integer, dimension(:), intent(in) :: id1_init,id2_init integer, dimension(:), allocatable, intent(out) :: id1_final,id2_final - real(dbl), dimension(:), allocatable :: alpha,delta, xstar, ystar, u, v,xx,yy + real(dbl), dimension(:), allocatable :: alpha,delta,xstar,ystar,u,v,xx,yy integer, dimension(:), allocatable :: id1, id2 type(AstroTrafoProj) :: t @@ -66,11 +66,12 @@ plog = pl ! check dimensions - if( size(a) /= size(d) ) stop 'Astrofit: alpha and delta sizes does not corresponds.' - if( size(x) /= size(y) ) stop 'Astrofit: xstar and ystar sizes does not corresponds.' + if( size(a) /= size(d) ) & + stop 'Astrofit: alpha and delta sizes does not corresponds.' + if( size(x) /= size(y) ) & + stop 'Astrofit: xstar and ystar sizes does not corresponds.' ! check stars > 1 ??? - if( .not. (size(id1_init) > 1) ) then rms = huge(rms) return @@ -99,22 +100,28 @@ end do ! an intial estimate of scale, rotation and reflection - call inestim(type,alpha,delta,xc,yc,xstar,ystar,acen,dcen,sc,dsc,rot,drot,refl,& - xoff,dxoff,yoff,dyoff,verbose) + call inestim(type,alpha,delta,xc,yc,xstar,ystar,acen,dcen,sc,dsc, & + rot,drot,refl,xoff,dxoff,yoff,dyoff,verbose) ! initial robust estimation - call absmin(type,alpha,delta,xc,yc,xstar,ystar,acen,dcen,sc,dsc,rot,drot,refl, & - xoff,dxoff,yoff,dyoff,mad,verbose) - if( plog ) write(*,'(a,en12.3,en13.3,f8.1,2f14.5)') "=AFIT> ",mad,sc,rot,acen,dcen + call absmin(type,alpha,delta,xc,yc,xstar,ystar,acen,dcen,sc,dsc, & + rot,drot,refl,xoff,dxoff,yoff,dyoff,mad,verbose) + if( plog ) & + write(*,'(a,en12.3,en13.3,f8.1,2f14.5)') "=AFIT> ",mad,sc,rot,acen,dcen ! estimator of MAD mad = max(mad,epsilon(1.0)) ! Important note: a numerical precision of MAD should not be higher than ! precision of coordinates stored in FITS files - single real precision! - if( debug ) & - write(*,'(2(a,g0.3),a)') '# astrofit mad=',mad,' deg ',3600.0*mad,' arcsec' -!stop + if( debug ) write(error_unit,'(2(a,g0.3),a)') & + '# astrofit mad=',mad,' deg ',3600.0*mad,' arcsec' + +! do i = 1,n +! write(*,*) real(xstar(i)),real(ystar(i)) +! end do +! stop + ! select such much stars as possible for final fit ! goto 222 deallocate(alpha,delta,xstar,ystar) @@ -123,8 +130,8 @@ ! In fact, the limit xsig is limit of clipping of data. dlim = xsig*max(sig/sc,mad) ! write(*,*) dlim,1.0/sc,mad - call listmatch(type,a,d,pma,pmd,x,y,epoch,jd,acen,dcen,xc,yc,sc,rot,refl,dlim, & - id1,id2,status) + call listmatch(type,a,d,pma,pmd,x,y,epoch,jd,acen,dcen,xc,yc,sc,& + rot,refl,dlim,id1,id2,status) n = size(id1) if( n < 1 .or. size(id1) /= size(id2) ) stop 'n < 1' allocate(alpha(n),delta(n),xstar(n),ystar(n)) @@ -133,10 +140,12 @@ call propercoo(jd,epoch,a(j),d(j),pma(j),pmd(j),alpha(i),delta(i)) xstar(i) = x(id2(i)) ystar(i) = y(id2(i)) +! write(*,*) real(xstar(i)),real(ystar(i)) end do !222 continue - if( debug ) write(*,'(a,i0)') '# astrofit stars to fit: ',n + if( debug ) & + write(error_unit,'(a,i0)') '# astrofit stars to fit: ',n if( n > 5 ) then @@ -144,7 +153,8 @@ call lsmin(type,alpha,delta,xc,yc,refl,xstar,ystar, & acen,dacen,dcen,ddcen,sc,dsc,rot,drot,rms,verbose) - if(plog) write(*,'(a,en12.3,en13.3,f8.1,2f14.5)') "=LSFIT> ",rms,sc,rot,acen,dcen + if(plog) write(*,'(a,en12.3,en13.3,f8.1,2f14.5)') & + "=LSFIT> ",rms,sc,rot,acen,dcen else ! if( fit == 'ROBUST' ) then @@ -153,7 +163,11 @@ call robmin(type,alpha,delta,xc,yc,refl,xstar,ystar,mad,& acen,dacen,dcen,ddcen,sc,dsc,rot,drot,rms,verbose,reliable) - if(plog) write(*,'(a,en12.3,en13.3,f8.1,2f14.5)') "=RFIT> ",rms,sc,rot,acen,dcen + if(plog) write(*,'(a,en12.3,en13.3,f8.1,2f14.5)') & + "=RFIT> ",rms,sc,rot,acen,dcen + + if( .not. reliable ) & + write(error_unit,*) 'Warning: Reliability test failed.' end if @@ -161,11 +175,12 @@ ! call lfit(type,alpha,delta,xstar,ystar, & ! xc,yc,acen,dacen,dcen,ddcen,sc,dsc,rms,pa,dpa) - call absmin(type,alpha,delta,xc,yc,xstar,ystar,acen,dcen,sc,dsc,rot,drot,refl,& - 0.0_dbl,0.0_dbl,0.0_dbl,0.0_dbl,rms,verbose) + call absmin(type,alpha,delta,xc,yc,xstar,ystar,acen,dcen,sc,dsc, & + rot,drot,refl,0.0_dbl,0.0_dbl,0.0_dbl,0.0_dbl,rms,verbose) rms = mad - if(plog) write(*,'(a,en12.3,en13.3,f8.1,2f14.5)') "=AFIT> ",rms,sc,rot,acen,dcen + if(plog) write(*,'(a,en12.3,en13.3,f8.1,2f14.5)') & + "=AFIT> ",rms,sc,rot,acen,dcen else @@ -175,7 +190,6 @@ end if - if( (rmscheck .and. rms*sc < xsig*sig ) .or. .not. rmscheck ) then ! residuals @@ -195,11 +209,13 @@ else allocate(id1_final(0),id2_final(0)) if(debug) then - write(*,*) 'rms*scale < xsig*sig: ',rms*sc,xsig*sig - write(*,*) - write(*,*) 'Most common occurrences:' - write(*,*) ' * crowded field misidentifying: increase --minmatch 6 (or more)' - write(*,*) ' * wide-field deformation: increase --sig or --sigcat' + write(error_unit,*) 'rms*scale < xsig*sig: ',rms*sc,xsig*sig + write(error_unit,*) + write(error_unit,*) 'Most common occurrences:' + write(error_unit,*) & + ' * crowded field mesh: increase --minmatch 6 (or more)' + write(error_unit,*) & + ' * wide-field deformation: increase --sig or --sigcat' end if end if diff -Nru munipack-0.5.9/astrometry/astrofits.f95 munipack-0.5.10/astrometry/astrofits.f95 --- munipack-0.5.9/astrometry/astrofits.f95 2017-07-17 23:03:48.000000000 +0000 +++ munipack-0.5.10/astrometry/astrofits.f95 2018-01-16 17:58:03.000000000 +0000 @@ -2,7 +2,7 @@ ! astrofits - write WCS to FITS image & read star table ! ! -! Copyright © 2011-3, 2015-6 F.Hroch (hroch@physics.muni.cz) +! Copyright © 2011-3, 2015-7 F.Hroch (hroch@physics.muni.cz) ! ! This file is part of Munipack. ! @@ -33,21 +33,25 @@ contains - subroutine readtable(filename, label_alpha, label_delta, label_pmalpha, label_pmdelta,& - label_mag, key_epoch, alpha, delta, pmalpha, pmdelta, refflux, rframe, catid, & - epoch,status) - - character(len=*), intent(in) :: filename, label_alpha, label_delta, label_pmalpha, & - label_pmdelta, label_mag, key_epoch - real(dbl), allocatable, dimension(:), intent(out) :: alpha, delta, pmalpha, pmdelta, refflux + subroutine readtable(filename, label_alpha, label_delta, label_pmalpha, & + label_pmdelta, label_mag, key_epoch, alpha, delta, pmalpha, pmdelta, & + refflux, rframe, catid, epoch,status) + + character(len=*), intent(in) :: filename, label_alpha, label_delta, & + label_pmalpha, label_pmdelta, label_mag, key_epoch + real(dbl), allocatable, dimension(:), intent(out) :: alpha, delta, & + pmalpha, pmdelta, refflux character(len=*), intent(out) :: rframe, catid real(dbl), intent(out) :: epoch integer, intent(out) :: status - real(dbl), parameter :: nullval = 1e33 + real(dbl), parameter :: nullcoo = 1e33, clim = 0.1*nullcoo + real(dbl), parameter :: nullmag = 99.999 + real(dbl), parameter :: mag25 = 25 integer, parameter :: ncols = 5, frow = 1, felem = 1 integer, dimension(ncols) :: col, statuses - integer :: nrows,i + real(dbl), allocatable, dimension(:) :: ra,dec,pmra,pmdec,mag + integer :: nrows,i,nr,n logical :: anyf character(len=FLEN_CARD) :: buf character(len=FLEN_VALUE), dimension(ncols) :: label,colname @@ -80,56 +84,77 @@ end if ! find columns by labels + statuses = 0 do i = 1, ncols colname(i) = '' - call ftgcnn(15,.false.,label(i),colname(i),col(i),status) - statuses(i) = status - if( (i == 1 .or. i == 2) .and. status /= 0 ) goto 666 + if( label(i) /= '' ) then + call ftgcnn(15,.false.,label(i),colname(i),col(i),statuses(i)) + else + statuses(i) = -1 + end if end do - status = 0 + if( any(statuses(1:2) /= 0) ) then + write(error_unit,*) & + 'Right Ascension and Declination columns are mandatory.' + status = maxval(statuses(1:2)) + goto 666 + end if if( nrows > 0 ) then - if( statuses(1) == 0 .and. statuses(2) == 0) then - allocate(alpha(nrows),delta(nrows)) - call ftgcvd(15,col(1),frow,felem,nrows,nullval,alpha,anyf,status) - call ftgcvd(15,col(2),frow,felem,nrows,nullval,delta,anyf,status) - else - goto 666 - end if + allocate(ra(nrows),dec(nrows),pmra(nrows),pmdec(nrows),mag(nrows)) - allocate(pmalpha(nrows),pmdelta(nrows)) - pmalpha = 0.0_dbl - pmdelta = 0.0_dbl - if( statuses(3) == 0 .and. statuses(4) == 0) then - call ftgcvd(15,col(3),frow,felem,nrows,nullval,pmalpha,anyf,status) - call ftgcvd(15,col(4),frow,felem,nrows,nullval,pmdelta,anyf,status) - if( status == 0 ) then - where( abs(pmalpha) < 0.1*nullval ) - pmalpha = pmalpha / 3.6e6_dbl ! supposing mas/year - elsewhere - pmalpha = 0.0_dbl - end where - where( abs(pmdelta) < 0.1*nullval ) - pmdelta = pmdelta / 3.6e6_dbl - elsewhere - pmdelta = 0.0_dbl - end where - end if - end if + ! coordinates + call ftgcvd(15,col(1),frow,felem,nrows,nullcoo,ra,anyf,status) + call ftgcvd(15,col(2),frow,felem,nrows,nullcoo,dec,anyf,status) + if( status /= 0 ) goto 666 - allocate(refflux(nrows)) - if( statuses(5) == 0 ) & - call ftgcvd(15,col(5),frow,felem,nrows,nullval,refflux,anyf,status) + ! proper motion + if( all(statuses(3:4) == 0) ) then + call ftgcvd(15,col(3),frow,felem,nrows,nullcoo,pmra,anyf,status) + call ftgcvd(15,col(4),frow,felem,nrows,nullcoo,pmdec,anyf,status) + if( status /= 0 ) goto 666 + where( abs(pmra) < clim ) + pmra = pmra / 3.6e6_dbl ! supposing mas/year + elsewhere + pmra = 0.0_dbl + end where + where( abs(pmdec) < clim ) + pmdec = pmdec / 3.6e6_dbl + elsewhere + pmdec = 0.0_dbl + end where + else + pmra = 0.0_dbl + pmdec = 0.0_dbl + end if - if( status == 0 ) then - refflux = 10.0**((25.0 - refflux)/2.5) + ! magnitudes + if( statuses(5) == 0 ) then + call ftgcvd(15,col(5),frow,felem,nrows,nullmag,mag,anyf,status) + if( status /= 0 ) goto 666 else - refflux = 1.0 + mag = mag25 end if end if + nr = min(count(abs(ra) < clim), count(abs(dec) < clim), count(mag < 99)) + allocate(alpha(nr),delta(nr),pmalpha(nr),pmdelta(nr),refflux(nr)) + + n = 0 + do i = 1, nrows + if( abs(ra(i)) < clim .and. abs(dec(i)) < clim .and. mag(i) < 99 ) then + n = n + 1 + alpha(n) = ra(i) + delta(n) = dec(i) + pmalpha(n) = pmra(i) + pmdelta(n) = pmdec(i) + refflux(n) = 10.0**((mag25 - mag(i))/2.5) + end if + end do + deallocate(ra,dec,pmra,pmdec,mag) + if( status /= 0 ) goto 666 call ftclos(15,status) @@ -137,18 +162,15 @@ 666 continue - if( allocated(alpha) ) deallocate(alpha,delta) - if( allocated(pmalpha) ) deallocate(pmalpha,pmdelta) - if( allocated(refflux) ) deallocate(refflux) - - call ftclos(15,status) + if( allocated(ra) ) deallocate(ra,dec,pmra,pmdec,mag) call ftrprt('STDERR',status) + call ftclos(15,status) end subroutine readtable - subroutine readfile(filename, key_dateobs, width, height, xcoo, ycoo, flux, crpix, jd, & - crval, sc, pa, refl, status) + subroutine readfile(filename, key_dateobs, width, height, xcoo, ycoo, flux, & + crpix, jd, crval, sc, pa, refl, status) use phio @@ -197,7 +219,8 @@ else if( status == KEYWORD_NOT_FOUND ) then status = 0 jd = 2451544.5_dbl - write(error_unit,*) trim(filename),": Keyword `",trim(key_dateobs),"' not found. Set to J2000.0." + write(error_unit,*) trim(filename),": Keyword `",trim(key_dateobs), & + "' not found. Set to J2000.0." else goto 666 end if @@ -218,7 +241,8 @@ ! FIND extension call ftmnhd(15,BINARY_TBL,FINDEXTNAME,extver,status) if( status == BAD_HDU_NUM ) then - write(error_unit,*) trim(FINDEXTNAME)//': extension not found. Coordinates of objects are not available yet.' + write(error_unit,*) trim(FINDEXTNAME)// & + ': extension not found. Coordinates of objects are not available.' goto 666 end if call ftgnrw(15,nrows,status) @@ -238,7 +262,8 @@ call ftmnhd(15,BINARY_TBL,APEREXTNAME,extver,status) if( status == BAD_HDU_NUM ) then status = 0 - ! aperture photometry is not available, no problem, we are continuing moreover + ! aperture photometry is not available, no problem, + ! we are continuing still and all ns = size(x) allocate(xcoo(ns),ycoo(ns),flux(ns)) xcoo = x @@ -246,12 +271,12 @@ flux = 1.0 else if( status == 0 ) then ! aperture photometry is available, we can use photometry informations - ! to improve robustness + ! to improve reliability call ftgcnn(15,.false.,trim(FITS_COL_APCOUNT)//"1",colname1,col1,status) allocate(cts(nrows)) call ftgcvd(15,col1,frow,felem,size(cts),nullval,cts,anyf,status) - ! we selecting stars with valid photometry only + ! we're selecting stars with valid photometry only ns = count(cts > 0.0) allocate(xcoo(ns),ycoo(ns),flux(ns)) ns = 0 @@ -270,7 +295,6 @@ call ftclos(15,status) deallocate(x,y) - return 666 continue @@ -291,19 +315,21 @@ real(dbl), intent(out) :: jd integer, intent(out) :: status - real(dbl) :: w, h, sc, pa, refl + real(dbl) :: w, h, sc, rot, refl real(dbl), allocatable, dimension(:) :: x,y real(dbl), dimension(2) :: crpix,crval type(AstroTrafoProj) :: t - call readfile(filename,key_dateobs,w,h,x,y,rflux,crpix,jd,crval,sc,pa,refl,status) + call readfile(filename,key_dateobs,w,h,x,y,rflux,crpix,jd,crval,& + sc,rot,refl,status) if( status == 0 .and. crval(1) > -666.0 .and. allocated(x) ) then allocate(alpha(size(x)),delta(size(x))) - call trafo_init(t,"GNOMONIC",crval(1),crval(2),crpix(1),crpix(2),sc,pa,refl) + call trafo_init(t,"GNOMONIC",crval(1),crval(2),crpix(1),crpix(2),& + scale=sc,rot=rot,refl=refl) call invtrafo(t,x,y,alpha,delta) deallocate(x,y) @@ -315,7 +341,8 @@ !----------------------------------------------------------------------------- - subroutine wcsupdate(file,type,crval,sc,pa,dpa,fcrpix,crpixels,refl,rms,com,status) + subroutine wcsupdate(file,type,crval,sc,pa,dpa,fcrpix,crpixels,refl,rms,& + com,status) use astrotrafo @@ -373,8 +400,10 @@ call ftukys(15,FITS_KEY_CREATOR,FITS_VALUE_CREATOR,FITS_COM_CREATOR,status) if( type == "GNOMONIC" )then - call FTUKYS(15,'CTYPE1','RA---TAN','the coordinate type for the first axis',status) - call FTUKYS(15,'CTYPE2','DEC--TAN','the coordinate type for the second axis',status) + call FTUKYS(15,'CTYPE1', & + 'RA---TAN','the coordinate type for the first axis',status) + call FTUKYS(15,'CTYPE2', & + 'DEC--TAN','the coordinate type for the second axis',status) else if( type == " " ) then call ftpmrk do i = 1,size(keys) @@ -427,7 +456,8 @@ end do ! no fitting - if( size(com) < 1 ) call ftpcom(15,"Astrometry calibration provided by user.",status) + if( size(com) < 1 ) & + call ftpcom(15,"Astrometry calibration provided by user.",status) call ftpcom(15,MUNIPACK_VERSION,status) call ftpcom(15,END_ASTROMETRY,status) diff -Nru munipack-0.5.9/astrometry/astromatch.f95 munipack-0.5.10/astrometry/astromatch.f95 --- munipack-0.5.9/astrometry/astromatch.f95 2017-07-17 23:03:48.000000000 +0000 +++ munipack-0.5.10/astrometry/astromatch.f95 2018-01-16 17:58:03.000000000 +0000 @@ -2,7 +2,7 @@ ! astromatch - matching engine ! ! -! Copyright © 2011-5 F.Hroch (hroch@physics.muni.cz) +! Copyright © 2011-5, 2017 F.Hroch (hroch@physics.muni.cz) ! ! This file is part of Munipack. ! @@ -10,21 +10,27 @@ ! it under the terms of the GNU General Public License as published by ! the Free Software Foundation, either version 3 of the License, or ! (at your option) any later version. -! +! ! Munipack is distributed in the hope that it will be useful, ! but WITHOUT ANY WARRANTY; without even the implied warranty of ! MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the ! GNU General Public License for more details. -! +! ! You should have received a copy of the GNU General Public License ! along with Munipack. If not, see . ! module astromatcher - + + use iso_fortran_env + implicit none - + integer, parameter, private :: dbl = selected_real_kind(15) + + ! maximal number of loop over frame stars + integer, parameter, private :: maxloop = 3 + character(len=80), private :: ptype real(dbl), dimension(:), pointer, private :: astar,dstar,xstar,ystar logical, private :: verbose, plog @@ -32,24 +38,26 @@ contains - subroutine astromatch(minmatch,maxmatch,type,a,d,pma,pmd,rflux,xx,yy,flux,ac,dc,xc,yc,& - id1,id2,sig1,sig2,fsig,fluxtest,epoch,jd,fullmatch,verb,pl,status) + subroutine astromatch(minmatch,maxmatch,type,a,d,pma,pmd,rflux, & + xx,yy,flux,ac,dc,xc,yc,id1,id2,sig1,sig2,fsig,fluxtest, & + epoch,jd,fullmatch,luckymatch,verb,pl,status) use astrotrafo use matcher - - integer, intent(in) :: minmatch, maxmatch + + integer, intent(in) :: minmatch, maxmatch, luckymatch logical, intent(in) :: fullmatch,verb, pl, fluxtest character(len=*), intent(in) :: type real(dbl), intent(in) :: ac,dc,xc,yc,sig1,sig2,fsig,epoch,jd - real(dbl), dimension(:), intent(in), target :: a, d, pma, pmd, xx, yy, flux, rflux + real(dbl), dimension(:), intent(in), target :: a, d, pma, pmd, xx, yy, & + flux, rflux integer, dimension(:), allocatable, intent(out) :: id1,id2 logical, intent(out) :: status real(dbl), dimension(:), allocatable :: u,v,x,y type(AstroTrafoProj) :: t real(dbl) :: dt - integer :: n1,n2,l,n + integer :: n1,n2,l,n,k,m status = .false. @@ -65,6 +73,8 @@ xcen = xc ycen = yc + if(verbose) write(error_unit,*) "=== Matching ===" + n1 = size(a) n2 = size(xx) allocate(x(n2),y(n2),u(n1),v(n1)) @@ -77,43 +87,54 @@ call trafo_init(t,type,ac,dc) call proj(t,a+dt*pma,d+dt*pmd,u,v) - n2 = min(maxmatch,size(x)) - l = 1 - - do n = 1, size(u)/maxmatch + 1 - n1 = min(maxmatch,size(u)-l) - 1 - if(verbose) then - write(*,*) "Selecting catalogue stars in rank:",l,l+n1 - write(*,*) "Matching... #: {seq1} -> {seq2} | scale,r: sq.(angle, scale, flux) < Xi2(0.95)" - end if - call match(u(l:l+n1),v(l:l+n1),rflux(l:l+n1),x(1:n2),y(1:n2),flux(1:n2), & - minmatch,maxmatch,sig1,sig2,fsig,fluxtest,id1,id2,& - fullmatch,matchprint,progress2,status) - if( status ) then - id1 = l + id1 - 1 - exit - end if - l = l + maxmatch + if( verbose ) then + write(error_unit,'(2(a,i0),a)') " Matching of ",size(u), & + " reference stars against to ",size(x)," frame stars:" + write(error_unit,*) & + "#: {seq1} -> {seq2} | scale,r: sq.(angle, scale, flux) < Xi2(0.95)" + end if + + k = 1 + do m = 1, min(size(x)/maxmatch + 1, maxloop) + n2 = min(maxmatch,size(x)-k) - 1 + l = 1 + do n = 1, size(u)/maxmatch + 1 + n1 = min(maxmatch,size(u)-l) - 1 + if(verbose) write(error_unit,'(2(2(a,i0),a))') & + " Reference stars in range ",l," -- ",l+n1,".", & + " Frame stars in range ",k," -- ",k+n2,"." + call match(u(l:l+n1),v(l:l+n1),rflux(l:l+n1), & + x(k:k+n2),y(k:k+n2),flux(k:k+n2), & + minmatch,maxmatch,sig1,sig2,fsig,fluxtest,id1,id2,& + fullmatch,luckymatch,matchprint,progress2,status) + if( status ) then + id1 = l + id1 - 1 + id2 = k + id2 - 1 + goto 99 + end if + l = l + maxmatch + end do + k = k + maxmatch end do - +99 continue + deallocate(u,v,x,y) end subroutine astromatch - subroutine matchprint(id1,id2,c,t,a,d,r,q) + subroutine matchprint(id1,id2,c,t,a,d,f,q) use matcher - + integer, dimension(:), intent(in) :: id1,id2 - real(dbl), intent(in) :: c,t,a,d,r,q + real(dbl), intent(in) :: c,t,a,d,f,q real(dbl), dimension(size(id1)) :: u,v integer :: i,n real(dbl) :: d3 character(len=80) :: fmt - if( size(id1) /= size(id2) ) stop 'Astromatch size(id1) /= size(id2)' n = size(id2) @@ -121,8 +142,8 @@ if( verbose ) then write(fmt,"(a,i0,a,i0,a)") "(i0,a,",n,"(1x,i0),a,",n, & - "(1x,i0),a,f0.1,2x,f0.2,a,3(2x,g0.3),a,f0.1)" - write(*,fmt) n,":",id1,' -> ',id2,' | ',c,t,': ',a,d,r,' < ',q + "(1x,i0),a,f0.1,2x,g0.2,a,3(2x,g0.3),a,f0.1)" + write(error_unit,fmt) n,":",id1,' -> ',id2,' | ',c,t,': ',a,d,f,' < ',q end if @@ -134,9 +155,10 @@ write(*,fmt) "=M> ",n,(xstar(id2(i)),ystar(id2(i)),i=1,n),a,d do i = 3,n - call triangle(xstar(i-2),ystar(i-2),xstar(i-1),ystar(i-1),xstar(i),ystar(i),d3,u(i),v(i)) + call triangle(xstar(i-2),ystar(i-2),xstar(i-1), & + ystar(i-1),xstar(i),ystar(i),d3,u(i),v(i)) end do - + write(fmt,"(a,i0,a)") "(a,i0,",2*(n-2),"(1x,f0.3))" write(*,fmt) "=MUV> ",n-2,(u(i),v(i),i=3,n) end if @@ -156,11 +178,12 @@ character(len=80) :: fmt,fm real(dbl), dimension(:), allocatable :: u,v integer :: n,m,i,i1,i2,i3 - real(dbl) :: ac,dc,sc,dsc,rot,drot,rms,amin,dmin,fmin,d3,refl,xoff,yoff,dxoff,dyoff + real(dbl) :: ac,dc,sc,dsc,rot,drot,rms,amin,dmin,fmin,d3,refl, & + xoff,yoff,dxoff,dyoff real(dbl), dimension(:), allocatable :: alpha,delta,x,y if( .not. plog ) return - + if( present(id2) ) then n = size(id2) @@ -177,16 +200,17 @@ x(i) = xstar(i2) y(i) = ystar(i2) end do - + ac = acen dc = dcen - call inestim(ptype,alpha,delta,xcen,ycen,x,y,ac,dc,sc,dsc,rot,drot,refl, & - xoff,yoff,dxoff,dyoff,verbose) - call absmin(ptype,alpha,delta,xcen,ycen,x,y,ac,dc,sc,dsc,rot,drot,refl, & + call inestim(ptype,alpha,delta,xcen,ycen,x,y,ac,dc,sc,dsc,rot,drot, & + refl,xoff,yoff,dxoff,dyoff,verbose) + call absmin(ptype,alpha,delta,xcen,ycen,x,y,ac,dc,sc,dsc,rot,drot,refl,& 0.0_dbl,0.0_dbl,0.0_dbl,0.0_dbl,rms,.false.) deallocate(alpha,delta,x,y) - write(*,'(a,en15.3,en25.15,en25.15,4en25.15)') "=MFIT> ",rms,sc,rot,ac,dc,xcen,ycen + write(*,'(a,en15.3,en25.15,en25.15,4en25.15)') & + "=MFIT> ",rms,sc,rot,ac,dc,xcen,ycen if( xdmin < 0.1*huge(xdmin) ) then amin = xamin @@ -197,12 +221,13 @@ amin = -1.0 fmin = -1.0 end if - + do i = 3,n i1 = id2(i) i2 = id2(i - 1) i3 = id2(i - 2) - call triangle(xstar(i3),ystar(i3),xstar(i2),ystar(i2),xstar(i1),ystar(i1),d3,u(i),v(i)) + call triangle(xstar(i3),ystar(i3),xstar(i2),ystar(i2), & + xstar(i1),ystar(i1),d3,u(i),v(i)) end do write(fmt,"(a,i0,a,i0,a)") "(a,3(1x,g0.7),1x,i0,",2*n,"(1x,f0.3),1x,i0," @@ -210,8 +235,8 @@ write(fm,'(i0,a)') 2*(n-2),"(1x,f0.3))" fmt = trim(fmt)//fm - write(*,fmt) "=MPROGRES2> ",amin,dmin,fmin,n,(xstar(id2(i)),ystar(id2(i)),i=1,n), & - m,(u(i),v(i),i=3,n) + write(*,fmt) "=MPROGRES2> ",amin,dmin,fmin,n, & + (xstar(id2(i)),ystar(id2(i)),i=1,n),m,(u(i),v(i),i=3,n) deallocate(u,v) else @@ -236,7 +261,7 @@ allocate(hist(nhist,nhist)) hist = 0 - ! the number of triangles is limited due faster user response + ! the number of triangles is limited to enable an acceptable user response c = max(size(x)/137,1) do i = 1, size(x) - 2,c @@ -259,4 +284,3 @@ end subroutine uvhist end module astromatcher - diff -Nru munipack-0.5.9/astrometry/astrometry.f95 munipack-0.5.10/astrometry/astrometry.f95 --- munipack-0.5.9/astrometry/astrometry.f95 2017-07-17 23:03:48.000000000 +0000 +++ munipack-0.5.10/astrometry/astrometry.f95 2018-01-16 17:58:03.000000000 +0000 @@ -2,7 +2,7 @@ ! astrometry ! ! -! Copyright © 2011-6 F.Hroch (hroch@physics.muni.cz) +! Copyright © 2011-7 F.Hroch (hroch@physics.muni.cz) ! ! This file is part of Munipack. ! @@ -24,6 +24,7 @@ ! ! * add all WCS related projections ! * add catalogue/reference matching identifier +! * add correlation matching by FFT with help of artificial ! ! testing: ! * improve high-precision algorithm to fit all parameters simulatenously @@ -63,8 +64,8 @@ mode = 'MATCH' character(len=FLEN_VALUE) :: rframe = '', idcat = '', key_epoch = 'EPOCH', & key_dateobs = 'DATE-OBS' - real(dbl), allocatable, dimension(:) :: alpha,delta,pmalpha,pmdelta,x,y,ares,dres, & - flux, rflux + real(dbl), allocatable, dimension(:) :: alpha,delta,pmalpha,pmdelta,x,y, & + ares,dres,flux, rflux integer, allocatable, dimension(:) :: id1,id2 integer, allocatable, dimension(:) :: i1,i2 character(len=FLEN_COMMENT), allocatable, dimension(:) :: com @@ -72,13 +73,15 @@ dcrval, xcrpix, xcrval real(dbl) :: tepoch,jd,scale = 1.0_dbl,dscale = epsilon(1.0_dbl), & angle = 0.0_dbl, dangle=epsilon(1.0_dbl), rms=0.0_dbl,a,da,b,db,s,ds,& - w,h,sm,refl=1.0_dbl + w,h,density,sm,refl=1.0_dbl real(dbl) :: sig2 = 1.0, sig1= 1.0/3600.0, xsig = 3.0, fsig = -1 integer :: eq,n,status,nseq,ncom integer :: minmatch = 5, maxmatch = 33 + integer :: luckymatch = 3 logical :: fcrpix = .false., fcrval = .false., reflex = .false. ,& - initpar = .true., matched = .false., rmscheck = .true., fluxtest = .true., & - verbose = .false., wcssave = .true., plog = .false., fullmatch = .true. + initpar = .true., matched = .false., rmscheck = .true., & + fluxtest = .true., verbose = .false., wcssave = .true., & + plog = .false., fullmatch = .false., init_match = .false. n = 0 ncom = 0 @@ -172,15 +175,23 @@ else if( key == 'MINMATCH' ) then read(val,*) minmatch + init_match = .true. else if( key == 'MAXMATCH' ) then read(val,*) maxmatch + init_match = .true. else if( key == 'FULLMATCH' ) then read(val,*) fullmatch + else if( key == 'LUCKYMATCH' ) then + + read(val,*) luckymatch + + if( luckymatch < 0 ) stop 'Lucky match requires one or more stars.' + else if( key == 'RMSCHECK' ) then read(val,*) rmscheck @@ -305,9 +316,10 @@ if( plog ) write(*,'(a)') "=ASTROMETRY> Start `"//trim(filename)//"'." status = 0 - call readfile(filename,key_dateobs,w,h,x,y,flux,crpix,jd,zcrval,scale,angle,refl,status) + call readfile(filename,key_dateobs,w,h,x,y,flux,crpix,jd,zcrval,scale, & + angle,refl,status) if( status /= 0 ) then - write(error_unit,*) "Failed to open the file: `"//trim(filename)//"'" + write(error_unit,*) "Error: Failed to open `" //trim(filename)//"'" goto 77 end if @@ -320,10 +332,27 @@ call uvhist(x,y) end if - call astromatch(minmatch,maxmatch,type,alpha,delta,pmalpha,pmdelta,rflux, & - x,y,flux,crval(1),crval(2),crpix(1),crpix(2),id1,id2,sig1,sig2,fsig,& - fluxtest,tepoch,jd,fullmatch,verbose,plog,matched) - !write(*,'(a,f10.7)') "=MATCH> End ",like + ! crowded field check, update parameters + if( .not. init_match ) then + density = size(x) / (w*h) ! stars per sq. pixel + if( density > 5e-4 ) then + minmatch = 6 + maxmatch = 36 + else + minmatch = 5 + maxmatch = 33 + end if + if(verbose) & + write(error_unit,'(2(a,i0),a)') & + ' Match parameters updated: minmatch=', & + minmatch,', maxmatch=',maxmatch,'.' + end if + + call astromatch(minmatch,maxmatch,type,alpha,delta,pmalpha,pmdelta, & + rflux,x,y,flux,crval(1),crval(2),crpix(1),crpix(2),id1,id2, & + sig1,sig2,fsig,fluxtest,tepoch,jd,fullmatch,luckymatch,& + verbose,plog,matched) +! write(*,'(a,f10.7)') "=MATCH> End " else if( mode == 'SEQUENCE' ) then @@ -341,18 +370,18 @@ if( .not. matched ) then if(plog) write(*,'(a)') "=ASTROMATCH> Finish Fail" - write(*,'(a)') "=C> Mutual match for files `"//trim(filename)//"' and `"// & - trim(cat)//trim(ref)//trim(rel)//"' failed." -! write(*,'(a,f6.3,a,f6.3,a)') "=C> (probability under limit: probability =", & -! like,' < validity=',0.5,")" + write(error_unit,'(7a)') "Warning: Mutual match for files `", & + trim(filename),"' and `",trim(cat),trim(ref),trim(rel), & + "' failed. No common stars found." else if( plog ) write(*,'(a)') "=ASTROMATCH> Finish Success" if( plog ) write(*,'(a)') "=ASTROFIT> Start" -! if( verbose ) write(*,'(a)') "=> Fitting ..." + ! if( verbose ) write(*,'(a)') "=> Fitting ..." call astrofit(fit,type,alpha,delta,pmalpha,pmdelta,x,y,sig2,xsig,& - tepoch,jd,crpix(1),crpix(2),crval(1),dcrval(1),crval(2),dcrval(2), & - scale,dscale,refl,rms,angle,dangle,ares,dres,id1,id2,i1,i2,rmscheck,verbose,plog) + tepoch,jd,crpix(1),crpix(2),crval(1),dcrval(1),crval(2),dcrval(2),& + scale,dscale,refl,rms,angle,dangle,ares,dres,id1,id2,i1,i2, & + rmscheck,verbose,plog) ! use a return flag instead ? if( size(i1) > 0 ) then @@ -426,17 +455,17 @@ end if write(com(7),'(a,f12.7,a,es7.1)') "cos(angle) = ",a," +- ",da write(com(8),'(a,f12.7,a,es7.1)') "sin(angle) = ",b," +- ",db - write(com(9),'(a,l5)') "Reflexion = ", reflex + write(com(9),'(a,l5)') "Reflexion = ", refl < 0 write(com(10),'(a,f11.5,a,es7.1,a)') "Angle of rotation(angle) = ", & angle," +- ",dangle," [deg]" if( aunits == 'pix' ) then - write(com(11), '(a,f12.7,a,es7.1)') "Alpha center projection (CRVAL1) = ", & - crval(1)," +- ",dcrval(1) - write(com(12),'(a,f12.7,a,es7.1)') "Delta center projection (CRVAL2) = ", & - crval(2)," +- ",dcrval(2) + write(com(11), '(a,f12.7,a,es7.1)') & + "Alpha center projection (CRVAL1) = ",crval(1)," +- ",dcrval(1) + write(com(12),'(a,f12.7,a,es7.1)') & + "Delta center projection (CRVAL2) = ",crval(2)," +- ",dcrval(2) else - write(com(11),'(a,f12.7,a,es7.1,a)') "Alpha center projection (CRVAL1) = ",& - crval(1)," +- ",dcrval(1)," [deg]" + write(com(11),'(a,f12.7,a,es7.1,a)') & + "Alpha center projection (CRVAL1) = ",crval(1)," +- ",dcrval(1)," [deg]" write(com(12),'(a,f12.7,a,es7.1,a)') "Delta center projection (CRVAL2) = ",& crval(2)," +- ",dcrval(2)," [deg]" end if @@ -463,8 +492,7 @@ end if ! if( plog ) write(*,'("=C> ",a)') (trim(com(n)),n=1,size(com)) - if( verbose ) write(*,'(a)') (trim(com(n)),n=1,size(com)) - + if( verbose ) write(error_unit,'(a)') (trim(com(n)),n=1,size(com)) if( wcssave ) then if( plog ) write(*,'(a)') "=WCSSAVE> Start" @@ -477,7 +505,8 @@ if( plog ) write(*,'(a)') "=WCSSAVE> Finish Success" else if( plog ) write(*,'(a)') "=WCSSAVE> Finish Fail" - write(*,*) "Save of WCS failed: `"//trim(filename)//"' to `"//trim(outname)//"'." + write(error_unit,*) "Warning: Save of WCS failed: `" & + //trim(filename)//"' to `"//trim(outname)//"'." end if end if @@ -486,7 +515,8 @@ else - write(error_unit,'(a)') "=> Astrometry of `"//trim(filename)//"' failed." + write(error_unit,'(a)') "Warning: Astrometry of `" // & + trim(filename)//"' failed." if( plog ) write(*,'(a)') "=ASTROFIT> Finish Fail" end if @@ -511,12 +541,13 @@ character(len=FLEN_FILENAME) :: outname integer :: status - if( verbose ) & - write(error_unit,*) "Manual astrometry calibration of `"//trim(filename)//"'." + if( verbose ) write(error_unit,*) & + "Manual astrometry calibration of `"//trim(filename)//"'." status = 0 call fitsback(filename,backup,output,.false.,outname,status) - call wcsupdate(outname,type,crval,scale,angle,dangle,fcrpix,crpix,refl,rms,com,status) + call wcsupdate(outname,type,crval,scale,angle,dangle,fcrpix,crpix,refl,rms,& + com,status) end subroutine mancal @@ -529,8 +560,8 @@ character(len=FLEN_FILENAME) :: outname integer :: status - if( verbose ) & - write(error_unit,*) "Removing astrometry calibration of `"//trim(filename)//"'." + if( verbose ) write(error_unit,*) & + "Removing astrometry calibration of `"//trim(filename)//"'." status = 0 call fitsback(filename,backup,output,.false.,outname,status) @@ -543,11 +574,9 @@ character(len=*), intent(in) :: rel - call readfile(rel,key_dateobs,w,h,x,y,rflux,xcrpix,tepoch,xcrval,scale,angle,refl,status) - if( status /= 0 ) then - write(error_unit,*) "Failed to open reference frame:`"//trim(rel)//"'" - stop 1 - end if + call readfile(rel,key_dateobs,w,h,x,y,rflux,xcrpix,tepoch,xcrval, & + scale,angle,refl,status) + if( status /= 0 ) stop 'Error: Opening of reference frame failed.' type = ' ' xcrval = 0.0_dbl @@ -568,10 +597,7 @@ character(len=*), intent(in) :: ref call reffile(ref,key_dateobs,alpha,delta,rflux,tepoch,status) - if( status /= 0 ) then - write(error_unit,*) "Failed to open reference frame:`"//trim(ref)//"'" - stop 1 - end if + if( status /= 0 ) stop 'Error: Opening of reference frame failed.' if( initpar ) call init(alpha,delta,xcrval(1),xcrval(2)) allocate(pmalpha(size(alpha)),pmdelta(size(delta))) @@ -586,10 +612,7 @@ call readtable(cat,col_ra,col_dec,col_pmra,col_pmdec,col_mag,& key_epoch,alpha,delta,pmalpha,pmdelta,rflux,rframe,idcat,tepoch,status) - if( status /= 0 ) then - write(error_unit,*) "Catalogue: `"//trim(cat)//"'" - stop "Failed to open the catalogue file." - end if + if( status /= 0 ) stop "Failed to open the catalogue file." if( initpar ) call init(alpha,delta,xcrval(1),xcrval(2)) end subroutine read_cat @@ -618,14 +641,16 @@ write(*,*) ' Method for fitting: ',trim(fit) write(*,*) ' Minimum stars for matching: ',minmatch write(*,*) ' Maximum stars for matching: ',maxmatch + write(*,*) ' Number stars for lucky matching: ',luckymatch write(*,*) ' Full match: ',fullmatch write(*,*) ' Check fluxes: ',fluxtest write(*,*) ' Check RMS: ',rmscheck write(*,*) ' Save results: ',wcssave - write(*,'(a,f0.1,a)') ' Mean uncertainty of centers stars on frame: ',sig2,' pix' - write(*,'(a,f0.1,a)') ' Mean uncertainty of stars in catalogue: ',sig1*3600.0, & - ' arcsec' + write(*,'(a,f0.1,a)') & + ' Mean uncertainty of centers stars on frame: ',sig2,' pix' + write(*,'(a,f0.1,a)') & + ' Mean uncertainty of stars in catalogue: ',sig1*3600.0,' arcsec' write(*,'(a,g0.1,a)') ' Mean uncertainty of fluxes: ',1.0 end subroutine show_defaults diff -Nru munipack-0.5.9/astrometry/estimator.f95 munipack-0.5.10/astrometry/estimator.f95 --- munipack-0.5.9/astrometry/estimator.f95 2017-07-17 23:03:48.000000000 +0000 +++ munipack-0.5.10/astrometry/estimator.f95 2018-01-16 17:58:03.000000000 +0000 @@ -2,7 +2,7 @@ ! absfit - fitting absolute deviations ! ! -! Copyright © 2015 F.Hroch (hroch@physics.muni.cz) +! Copyright © 2015, 2017 F.Hroch (hroch@physics.muni.cz) ! ! This file is part of Munipack. ! @@ -10,18 +10,20 @@ ! it under the terms of the GNU General Public License as published by ! the Free Software Foundation, either version 3 of the License, or ! (at your option) any later version. -! +! ! Munipack is distributed in the hope that it will be useful, ! but WITHOUT ANY WARRANTY; without even the implied warranty of ! MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the ! GNU General Public License for more details. -! +! ! You should have received a copy of the GNU General Public License ! along with Munipack. If not, see . ! module estimator - + + use iso_fortran_env + implicit none logical, private :: debug = .true. @@ -32,8 +34,8 @@ contains - subroutine inestim(type,a,d,xc,yc,xx,yy,acen,dcen,sc,dsc,rot,drot,refl,xoff,dxoff,& - yoff,dyoff,verbose) + subroutine inestim(type,a,d,xc,yc,xx,yy,acen,dcen,sc,dsc,rot,drot,refl, & + xoff,dxoff,yoff,dyoff,verbose) use astrotrafo @@ -49,7 +51,7 @@ if( size(a) < 1 ) stop 'InEstim: no points available.' - if(verbose) write(*,*) "=== Parameters estimation ===" + if(verbose) write(error_unit,*) "=== Parameters estimation ===" debug = verbose @@ -69,7 +71,7 @@ call erot(u,v,x,y,rot,drot) ! offset - ! origin of rectangular coordinates is moved to center of frame + ! origin of rectangular coordinates is moved to center of frame ! because that's point the frame is rotated around call trafo_init(t,xcen=xc,ycen=xc,scale=sc,rot=rot,refl=refl) call invaffine(t,xx,yy,x,y) @@ -90,7 +92,7 @@ integer :: i,j,n real(dbl),dimension(:),allocatable :: cc - real(dbl) :: d1,d2 + real(dbl) :: d1,d2,e allocate(cc(size(x)**2)) @@ -106,15 +108,16 @@ enddo if( n > 1 ) then - call rmean(cc(1:n),c,dc) - else + call rmean(cc(1:n),c,e,dc) + else c = 0.0_dbl dc = 0.0_dbl end if deallocate(cc) - if( debug ) write(*,'(a,2f10.1)') '# estim init scale [pix/deg]: ',1/c,dc/c**2 + if( debug ) write(error_unit,'(a,f10.1,g10.2)') & + '# estim init scale [pix/deg]: ',1/c,dc/c**2 end subroutine escale @@ -128,7 +131,7 @@ integer :: i,j,n real(dbl),dimension(:),allocatable :: cc,cs - real(dbl) :: d1,d2,x1,y1,x2,y2,c,s,dc,ds + real(dbl) :: d1,d2,x1,y1,x2,y2,c,s,dc,ds,e n = size(x) - 1 allocate(cc(n),cs(n)) @@ -145,12 +148,12 @@ cc(i) = (x1*x2 + y1*y2)/(d1*d2) ! sin cs(i) = (x1*y2 - x2*y1)/(d1*d2) -! if(debug) write(*,'(a,6f12.5)') '# erot ',x(i),y(i),u(i),v(i),cc(i),cs(i) +! if(debug)write(*,'(a,6f12.5)') '# erot ',x(i),y(i),u(i),v(i),cc(i),cs(i) enddo if( n > 1 ) then - call rmean(cc,c,dc) - call rmean(cs,s,ds) + call rmean(cc,c,e,dc) + call rmean(cs,s,e,ds) f = rad * sign(atan2(abs(s),c),s) if( abs(s) > 0 ) then df = rad*sqrt(ds**2 + (c/s)**2*dc**2) @@ -164,7 +167,8 @@ deallocate(cc,cs) - if( debug ) write(*,'(a,2f8.3)') '# estim init angle [deg]: ',f,df + if( debug ) write(error_unit,'(a,f8.3,g10.2)') & + '# estim init angle [deg]: ',f,df end subroutine erot @@ -207,7 +211,7 @@ k = i + 2 f1 = angle(x(i),y(i),x(j),y(j),x(k),y(k)) f2 = angle(u(i),v(i),u(j),v(j),u(k),v(k)) - + if( f1*f2 >= 0 ) then r(i) = 1 else @@ -224,8 +228,8 @@ deallocate(r) - if( debug ) write(*,'(a,f5.0)') '# estim init reflexion: ',refl - + if( debug ) write(error_unit,'(a,f5.0)') '# estim init reflexion: ',refl + end subroutine ereflex subroutine eoff(u,v,x,y,xoff,dxoff,yoff,dyoff) @@ -238,6 +242,7 @@ integer :: i,n real(dbl),dimension(:),allocatable :: du,dv + real(dbl) :: e n = size(x) allocate(du(n),dv(n)) @@ -249,8 +254,8 @@ end do if( n > 1 ) then - call rmean(du,xoff,dxoff) - call rmean(dv,yoff,dyoff) + call rmean(du,xoff,e,dxoff) + call rmean(dv,yoff,e,dyoff) else xoff = 0.0_dbl yoff = 0.0_dbl @@ -260,8 +265,8 @@ deallocate(du,dv) - if( debug ) write(*,'(a,4f12.5)') '# estim init offset [deg]: ', & - xoff,yoff,dxoff,dyoff + if( debug ) write(error_unit,'(a,2f12.5,2g10.2)') & + '# estim init offset [deg]: ',xoff,yoff,dxoff,dyoff end subroutine eoff diff -Nru munipack-0.5.9/astrometry/Makefile.in munipack-0.5.10/astrometry/Makefile.in --- munipack-0.5.9/astrometry/Makefile.in 2017-07-17 23:04:25.000000000 +0000 +++ munipack-0.5.10/astrometry/Makefile.in 2018-01-16 17:58:14.000000000 +0000 @@ -275,7 +275,6 @@ builddir = @builddir@ datadir = @datadir@ datarootdir = @datarootdir@ -develop = @develop@ docdir = @docdir@ dvidir = @dvidir@ exec_prefix = @exec_prefix@ diff -Nru munipack-0.5.9/astrometry/match.f95 munipack-0.5.10/astrometry/match.f95 --- munipack-0.5.9/astrometry/match.f95 2017-07-17 23:03:48.000000000 +0000 +++ munipack-0.5.10/astrometry/match.f95 2018-01-16 17:58:03.000000000 +0000 @@ -2,7 +2,7 @@ ! match finding of cross identification between two lists ! the core of the matching algorithm ! -! Copyright © 2010 - 2015 F.Hroch (hroch@physics.muni.cz) +! Copyright © 2010 - 2015, 2017 F.Hroch (hroch@physics.muni.cz) ! ! This file is part of Munipack. ! @@ -10,12 +10,12 @@ ! it under the terms of the GNU General Public License as published by ! the Free Software Foundation, either version 3 of the License, or ! (at your option) any later version. -! +! ! Munipack is distributed in the hope that it will be useful, ! but WITHOUT ANY WARRANTY; without even the implied warranty of ! MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the ! GNU General Public License for more details. -! +! ! You should have received a copy of the GNU General Public License ! along with Munipack. If not, see . ! @@ -35,15 +35,17 @@ logical, private, dimension(:), allocatable :: idx1, idx2 real(rp), private, dimension(:), pointer :: x1,y1,x2,y2,f1,f2 real, private, dimension(:,:,:,:), allocatable :: tris1,tris2 - real(rp), private :: amin, dmin, fmin, tflux, scale - real(rp), private :: sig1 = 1.0/3600.0, sig2 = 1.0, fsig = 1 - real(rp), private :: xsig = 2.0 ! Normal limit at 95% - real(rp), private :: rsig = 3.8 ! Rayleigh limit at 95% - real(rp), private :: fweight = 1 ! 1 .. use flux, 0.. don't use flux + real(rp), private :: amin, dmin, fmin, tflux, sflux, scale + real(rp), private :: sig1 = 1.0/3600.0 ! spherical coordinate limit [deg] + real(rp), private :: sig2 = 1.0 ! on chip coordinate limit [pix] + real(rp), private :: xsig = 2.0 ! Normal distribution limit at 95% + real(rp), private :: rsig = 3.8 ! Rayleigh distribution limit at 95% + real(rp), private :: fuse = 1 ! =1 .. use flux, =0.. don't use flux + real(rp), private :: fsig = 1 ! flux limit in sigmas real(rp), private :: dtol1, dtol2, rtol1, rtol2 integer, private :: nseq, nid integer, private :: minmatch = 5 - integer, private :: maxmatch = 50 + integer, private :: maxmatch = 30 logical, private :: stopping = .false. logical, private :: progres2 = .false. @@ -55,7 +57,7 @@ contains subroutine match(x_1,y_1,f_1,x_2,y_2,f_2,nm,mm,sigma1,sigma2,fsigma, & - fluxtest,id_1,id_2,fullmatch,matchprint,progress2,status) + fluxtest,id_1,id_2,fullmatch,luckymatch,matchprint,progress2,status) implicit none @@ -78,11 +80,11 @@ real(rp), dimension(:), intent(in), target :: x_1,y_1,x_2,y_2,f_1,f_2 integer, dimension(:), allocatable, intent(out) :: id_1, id_2 logical, intent(in) :: fullmatch, fluxtest - integer, intent(in) :: nm, mm + integer, intent(in) :: nm, mm, luckymatch real(rp), intent(in) :: sigma1, sigma2, fsigma logical, intent(out) :: status integer :: i1,i2,j1,j2,ns,ntot - real(rp) :: d1,d2,s,f,xlim + real(rp) :: d1,d2,f,xlim status = .false. @@ -96,16 +98,21 @@ if( size(x1) /= size(y1) .or. size(x2) /= size(y2) ) & stop 'Match: Array dimensions does not matches.' + if( (.not. all(f1 > 0)) .or. (.not. all(f2 > 0)) ) & + stop 'Match: All fluxes must be > 0.' + if( nm > 0 ) minmatch = nm if( mm > 0 ) maxmatch = mm if( sigma1 > 0.0 ) sig1 = sigma1 if( sigma2 > 0.0 ) sig2 = sigma2 if( fsigma > 0 ) fsig = fsigma - if( .not. fluxtest ) fweight = 0 + if( .not. fluxtest ) fuse = 0 + + allocate(id1(maxmatch),id2(maxmatch),seq1(0),seq2(0), & + idx1(maxmatch),idx2(maxmatch), & + tris1(maxmatch,maxmatch,maxmatch,3),tris2(maxmatch,maxmatch,maxmatch,3)) - allocate(id1(maxmatch),id2(maxmatch),seq1(0),seq2(0),idx1(maxmatch),idx2(maxmatch)) - allocate(tris1(maxmatch,maxmatch,maxmatch,3),tris2(maxmatch,maxmatch,maxmatch,3)) tris1 = -1 tris2 = -1 @@ -156,10 +163,14 @@ if( .not. in_idx(seq2,id2(1:2)) .and. d2 > dtol2 ) then ! check fluxes, optionaly - call mflux(f1(id1(1:nid)),f2(id2(1:nid)),tflux,s) - f = fsq(tflux,fsig,f1(id1(1:nid)),f2(id2(1:nid))) + if( fuse > 0 ) then + call mflux(f1(id1(1:nid)),f2(id2(1:nid)),tflux,sflux) + f = fsq(tflux,fsig*sflux,f1(id1(1:nid)),f2(id2(1:nid))) + else + f = 0 + end if - if( f*fweight < xlim ) then + if( f*fuse < xlim ) then ! setup of coordinate scale and the mean flux ratio scale = escale(x1,y1,id1(1:nid),x2,y2,id2(1:nid)) @@ -170,10 +181,14 @@ call seq(matchprint) ! show the longest sequence - if( progres2 ) call progress2(ns,ntot,amin,dmin,fmin,seq1,seq2) + if( progres2 ) & + call progress2(ns,ntot,amin,dmin,fmin,seq1,seq2) + + ! finish on first success attempt (luckymatch == 0), + ! or finish when results looks reliable (>0) + if( .not. fullmatch & + .and. nseq >= minmatch + luckymatch ) goto 666 - ! finish on first success attempt - if( .not. fullmatch .and. nseq >= minmatch ) goto 666 end if end if end do @@ -215,7 +230,7 @@ integer :: i,j,i1,i2,j1,j2,i0,j0,n1 real(rp) :: u1, v1, u2, v2, d1, d2, tol, & - tol1, tol2, au, av, fres, sres, s, a, d, f, xlim + tol1, tol2, au, av, fres, sres, a, d, f, s, xlim, xlin logical :: launch if( stopping ) return @@ -226,7 +241,8 @@ j1 = id2(n1) j2 = id2(nid) - xlim = qchi2(nid) + xlin = qchi2(nid) + xlim = qchi2(2) launch = .false. do i = 1, size(x1) @@ -238,7 +254,7 @@ call triangle(x1(i1),y1(i1),x1(i2),y1(i2),x1(i),y1(i),d1,u1,v1) tris1(i1,i2,i,:) = real((/u1,v1,d1/)) ! counter = counter + 1 - + else u1 = tris1(i1,i2,i,1) v1 = tris1(i1,i2,i,2) @@ -254,13 +270,18 @@ do j = 1, size(x2) - fres = fsq(tflux,fsig,(/f1(i)/),(/f2(j)/)) + if( fuse > 0 ) then + fres = fsq(tflux,fsig*sflux,(/f1(i)/),(/f2(j)/)) + else + fres = 0 + end if + + if( idx2(j) .and. fres*fuse < xlim ) then - if( idx2(j) .and. fres*fweight < xlim ) then - if( tris2(j1,j2,j,1) < 0.0 ) then - call triangle(x2(j1),y2(j1),x2(j2),y2(j2),x2(j),y2(j),d2,u2,v2) + call triangle(x2(j1),y2(j1),x2(j2),y2(j2),x2(j),y2(j), & + d2,u2,v2) tris2(j1,j2,j,:) = real((/u2,v2,d2/)) else @@ -272,7 +293,7 @@ tol2 = sq2 * rtol2 / d2 if( d2 > dtol2 .and. v2 > (1 + tol2 - u2) ) then - + tol = tol1 + tol2 au = abs(u1 - u2) @@ -302,23 +323,32 @@ a = angels(x1,y1,id1(1:nid),x2,y2,id2(1:nid)) ! dispersion of fluxes (optional) - call mflux(f1(id1(1:nid)),f2(id2(1:nid)),tflux,s) - f = fsq(tflux,s,f1(id1(1:nid)),f2(id2(1:nid))) + if( fuse > 0 ) then + call mflux(f1(id1(1:nid)),f2(id2(1:nid)),tflux,s) + f = fsq(tflux,fsig*s,f1(id1(1:nid)),f2(id2(1:nid))) + else + f = 0 + end if ! head and tail of sequence on similarity of triangles i0 = id1(1) j0 = id2(1) - call triangle(x1(i0),y1(i0),x1(i2),y1(i2),x1(i),y1(i),d1,u1,v1) - call triangle(x2(j0),y2(j0),x2(j2),y2(j2),x2(j),y2(j),d2,u2,v2) + call triangle(x1(i0),y1(i0),x1(i2),y1(i2), & + x1(i),y1(i),d1,u1,v1) + call triangle(x2(j0),y2(j0),x2(j2),y2(j2), & + x2(j),y2(j),d2,u2,v2) tol = sq2*(rtol1/d1 + rtol2/d2) - if( a < xlim .and. d < xlim .and. f*fweight < xlim .and. & - abs(u1 - u2) < tol .and. abs(v1 - v2) < tol ) then + if( a < xlin & + .and. d < xlin & + .and. f*fuse < xlin & + .and. abs(u1 - u2) < tol & + .and. abs(v1 - v2) < tol ) then progres2 = .true. - call matchprint(id1(1:nid),id2(1:nid),scale,tflux,a,d,f,xlim) - if( nid >= nseq .and. & - (amin > a .or. dmin > d .or. fmin > f) ) then + call matchprint(id1(1:nid),id2(1:nid),scale,tflux,& + a,d,f,xlin) + if( nid >= nseq ) then nseq = nid amin = a dmin = d @@ -334,14 +364,14 @@ nid = nid - 1 idx1(i) = .true. idx2(j) = .true. - + end if end if end if end do ! j end if end if - end do ! i + end do ! i ! none matching stars has been found, ! => next subroutine invocation will be stopped @@ -447,13 +477,18 @@ function dsq(s,d1,d2,sig1,sig2) real(rp) :: dsq - real(rp), parameter :: sq2 = sqrt(2.0) + real(rp), parameter :: sq2 = sqrt(2.0_rp) real(rp), intent(in) :: s real(rp), dimension(:), intent(in) :: d1,d2 real(rp), intent(in) :: sig1,sig2 - real(rp), dimension(size(d1)) :: r + real(rp), dimension(size(d1)) :: r,dr - r = (d2 - s*d1)/(sq2*sqrt((s*sig1)**2 + sig2**2)) + dr = (s*sig1)**2 + sig2**2 + where( dr > 0 ) + r = (d2 - s*d1)/(sq2*sqrt(dr)) + elsewhere + r = 1 + end where dsq = sum(r**2) end function dsq @@ -520,7 +555,7 @@ ! ! |a1 - a2| ! --------- - ! sig + ! sig ! ! where sig=sqrt(da1**2 + da2**2) @@ -541,16 +576,16 @@ subroutine mflux(f1,f2,t,s) ! determines estimation of ratio and its error - ! by arithmetical mean (non-robust) + ! by arithmetical mean (intentionally non-robust) real(rp), dimension(:), intent(in) :: f1,f2 real(rp), intent(out) :: t,s real(rp), dimension(size(f1)) :: r - integer :: n + integer :: n - n = size(f1) - r = f1 / f2 + n = size(r) + r = f1 / f2 t = sum(r)/n s = sqrt(sum((r-t)**2)/(n-1)) @@ -559,21 +594,22 @@ function fsq(t,s,f1,f2) - ! returns squares of residuals of + ! returns squares of residuals of ! (f1 - t* f2)**2 / sqrt(f1 + t**2*f2 + f2**2*s**2)**2 ! suitable for test by chi2 statistics ! - ! the last term of errors is due to t-error and - ! generaly is induced by mechanims not connected - ! on photon statistics (clouds, ..) + ! the last term of errors describes t noise and + ! generaly is due effects not directly connected + ! on photon statistics (clouds, background, ..) real(rp) :: fsq real(rp),intent(in) :: t,s real(rp), dimension(:), intent(in) :: f1,f2 - real(rp), dimension(size(f1)) :: r + real(rp), dimension(size(f1)) :: dr,r2 - r = (f1 - t*f2)/sqrt(f1 + t**2*f2 + f2**2*s**2) - fsq = sum(r**2) + dr = f1 + t**2*f2 + (f2*s)**2 + r2 = (f1 - t*f2)**2 + fsq = sum(r2 / dr) end function fsq @@ -609,7 +645,7 @@ ! 0.95 1.645 ! 0.99 2.326 ! 0.999 3.090 - ! + ! real :: qchi2 real, parameter :: u = 1.645 @@ -620,4 +656,3 @@ end function qchi2 end module matcher - diff -Nru munipack-0.5.9/astrometry/nearmatch.f95 munipack-0.5.10/astrometry/nearmatch.f95 --- munipack-0.5.9/astrometry/nearmatch.f95 2017-07-17 23:03:48.000000000 +0000 +++ munipack-0.5.10/astrometry/nearmatch.f95 2018-01-16 17:58:03.000000000 +0000 @@ -45,6 +45,7 @@ type(AstroTrafoProj) :: t real(dbl) :: smin,smin0,s,dt integer :: nsize,msize,n,i,j,idx + logical :: found status = .false. @@ -87,9 +88,24 @@ end do if( idx > 0 ) then - n = n + 1 - id1(n) = i - id2(n) = idx + ! check whatever the star is already presented, + ! it will be ignored, because brighter ones are prefered + ! (and we are supposing flux-sorted lists). + found = .false. + do j = 1, n + if( idx == id2(j) ) then + found = .true. + goto 99 + end if + end do +99 continue + + if( .not. found ) then + n = n + 1 + id1(n) = i + id2(n) = idx + end if + ! if( debug ) write(*,'(f10.3,2i5,2f15.2)') smin,i,idx,u(i)-x(idx),v(i)-y(idx) diff -Nru munipack-0.5.9/astrometry/robfit.f95 munipack-0.5.10/astrometry/robfit.f95 --- munipack-0.5.9/astrometry/robfit.f95 2017-07-17 23:03:48.000000000 +0000 +++ munipack-0.5.10/astrometry/robfit.f95 2018-01-16 17:58:03.000000000 +0000 @@ -21,10 +21,13 @@ module robfit + use iso_fortran_env + implicit none logical, private :: debug = .false. logical, private :: analytic = .true. + logical, private :: rnewton = .false. integer, parameter, private :: dbl = selected_real_kind(15) real(dbl), parameter, private :: rad = 57.295779513082322865_dbl real(dbl), dimension(:), allocatable, private :: uref,vref @@ -32,11 +35,12 @@ real(dbl), private :: refl, xcen, ycen, sig integer, private :: ndat - private :: dres, minfun, fundif, funder, difjac, hessian_min + private :: dres, minfun, fundif, funder, difjac, difvec, hessian_min contains - subroutine robmin(type,a,d,xc,yc,rf,xx,yy,mad,acen,dacen,dcen,ddcen,sc,dsc,pa,dpa,rms,verbose,reliable) + subroutine robmin(type,a,d,xc,yc,rf,xx,yy,mad,acen,dacen,dcen,ddcen, & + sc,dsc,pa,dpa,rms,verbose,reliable) ! find proper transformation by robust mean squares @@ -63,16 +67,17 @@ real(dbl),dimension(npar,npar) :: fjac,cov real(dbl),dimension(:), allocatable :: du,dv,res integer :: iter,i,j,info,nprint,ifault,nra,ndec - real(dbl) :: s0,sum1,sum2,wx,wy,s,smin + real(dbl) :: s,smin type(AstroTrafoProj) :: t,ti - character(len=80), parameter :: fmt = '(2i2,es10.2,2f11.5,2g12.3,f10.1,f7.1)' + character(len=80), parameter :: fmt = & + '(2i2,es10.2,2f11.5,2g12.3,f10.1,f7.1)' character(len=20) :: fmt1 logical :: reli debug = verbose reliable = .false. - if(debug) write(*,*) '=== Robust fitting ===' + if(debug) write(error_unit,*) '=== Robust fitting ===' rms = huge(rms) refl = rf @@ -85,7 +90,6 @@ if( .not. (ndat > npar) ) stop 'Robust fitting requires five stars > 5.' if( mad < epsilon(mad) ) stop 'Robust fit needs mad > 0.' - ! normalization allocate(uref(ndat),vref(ndat),du(ndat),dv(ndat),res(2*ndat)) call trafo_init(t,type,acen,dcen) @@ -101,67 +105,67 @@ dp(4) = 0.1 / rad do iter = 1, precision(p) - nprint = 0 ! or 1 ! Update estimate of parameters by method without derivation ! Because there are no methods reliable for finding of roots ! in multidimensional case, we replaced root finding by minimizing. pmin = p call nelmin1(minfun,pmin,dp,smin,ifault) - if( debug ) write(*,fmt) iter,ifault,sig,acen,dcen,p(1:2)/p(3),1/p(3),rad*p(4) if( ifault == 0 ) then p = pmin - ! update estimate of dispersion by entropy - call dres(p,res(1:ndat),res(ndat+1:2*ndat)) - s = sig - call escale(res,s,reli) - if( reli ) sig = s + ! update estimate of dispersion by entropy, + ! apllied only on the already iterated center of projection + if( iter > 1 ) then + call dres(p,res(1:ndat),res(ndat+1:2*ndat)) + s = sig + call escale(res,s,reli) + + ! accept only realiable estimates + if( reli .and. iter > 1 ) sig = s + end if else ! what to do when nelmin fails? - continue + if( iter > 1 ) then + reliable = .false. + exit + end if end if - if( analytic ) then - call lmder2(funder,p,eps,nprint,info) - else - call lmdif2(fundif,p,eps,nprint,info) - end if - if( info == 0 ) stop 'Warning: robfit: Improper input parameters.' - ! testing errors: - ! if( info == 4 ? ) write(error_unit,*) 'No konvergence.' + if( debug ) write(error_unit,fmt) & + iter,ifault,sig,acen,dcen,p(1:2)/p(3),1/p(3),rad*p(4) - ! residual sum - call dres(p,du,dv) - sum1 = 0.0_dbl - sum2 = 0.0_dbl - do i = 1, ndat - wx = du(i)/sig - wy = dv(i)/sig - sum1 = sum1 + tukey(wx)**2 + tukey(wy)**2 - sum2 = sum2 + dtukey(wx) + dtukey(wy) - enddo - - ! robust estimate of sum of squares in minimum - if( sum1 > 0 .and. sum2 > 0 ) then - s0 = sig**2*sum1/sum2**2*ndat**2 - rms = sqrt(s0 / (ndat - npar)) - else - s0 = -1 - rms = -1 + if( rnewton ) then + ! This code has origin in the gold good times, when + ! no divengence could have occured and the robust function + ! has been on base Huber's minimax(). There is no place + ! for the approach when some descending functions performs + ! estimates. + + nprint = 0 ! or 1 + if( analytic ) then + call lmder2(funder,p,eps,nprint,info) + else + call lmdif2(fundif,p,eps,nprint,info) + end if + if( info == 0 ) stop 'Warning: robfit: Improper input parameters.' + ! possible errors: + ! if( info == 4 ? ) write(error_unit,*) 'No convergence.' + if( debug ) write(error_unit,fmt) & + iter,info,sig,acen,dcen,p(1:2)/p(3),1/p(3),rad*p(4) end if - if( debug ) write(*,fmt) iter,info,sig,acen,dcen,p(1:2)/p(3),1/p(3),rad*p(4) - ! finish when location parameters are appropriate small ! and iterations couldn't made further progress - ! if( iter > 1 .and. all(abs(p(1:2)) < eps) ) exit - ! the precision is better than 1/1000 of a pixel - if( iter > 1 .and. all(abs(p(1:2)/p(3)) < 0.001) ) exit + ! the precision is set to be better than 1/1000 of a pixel + if( iter > 1 .and. all(abs(p(1:2)/p(3)) < 0.001) .and. ifault == 0 ) then + reliable = .true. + exit + end if ! update center of projection and projected coordinates call trafo_init(ti,type,acen=acen,dcen=dcen, & @@ -173,58 +177,63 @@ end do - call hessian_min(p,fjac) - call qrinv(fjac,cov) - ! statistical errors of parameters ! Hessian is recomputed analyticaly in view of the fact that ! we needs errors of acen, dcen (but p(1:2) are X0,Y0) and ! Jacobian by lmdif2 is scaled by errors (multiplication of s**2 ! is satisfactory only for p(3:4). + call hessian_min(p,fjac) + call qrinv(fjac,cov) if( debug ) then write(fmt1,'(a,i0,a)') '(a,',npar,'g15.5)' - write(*,'(a)') '# Hessian at minimum:' - write(*,fmt1) ('#',fjac(i,:),i=1,npar) - write(*,'(a)') '# Covariance matrix (no regularisation):' - write(*,fmt1) ('#',cov(i,:),i=1,npar) - write(*,'(a)') '# Correlation matrix:' + write(error_unit,'(a)') '# Hessian at minimum:' + write(error_unit,fmt1) ('#',fjac(i,:),i=1,npar) + write(error_unit,'(a)') '# Covariance matrix (no regularisation):' + write(error_unit,fmt1) ('#',cov(i,:),i=1,npar) + write(error_unit,'(a)') '# Correlation matrix:' do i = 1,npar - write(*,'(a)',advance="no") '#' + write(error_unit,'(a)',advance="no") '#' do j = 1,npar - write(*,'(f9.3)',advance="no") cov(i,j)/sqrt(cov(i,i)*cov(j,j)) + if( cov(i,i) > 0 .and. cov(j,j) > 0 ) then + write(error_unit,'(f9.3)',advance="no") & + cov(i,j)/sqrt(cov(i,i)*cov(j,j)) + else + ! Hessian is not regularised and Tukey's function has been used. + write(error_unit,'(a9)',advance="no") ' *** ' + end if end do - write(*,*) + write(error_unit,*) end do end if dp = -1 do i = 1,npar - if( s0 > 0 .and. cov(i,i) > 0 ) & - dp(i) = sqrt(s0*cov(i,i)/(ndat - npar)) + if( sig > 0 .and. cov(i,i) > 0 ) & + dp(i) = sqrt(sig**2*cov(i,i)/(ndat - npar)) end do sc = 1.0_dbl/p(3) pa = rad*p(4) ! deviations of output parameters - dacen = dp(1) / cos(dcen / rad) !*sc??? ! cos() sqeezes metric (distance) on sphere - ddcen = dp(2) !*sc??? + dacen = dp(1) / cos(dcen / rad) ! cos() sqeezes metric (distance) on sphere + ddcen = dp(2) dsc = sc*(dp(3)/p(3)) dpa = rad*dp(4) + rms = sig if( debug ) then + call dres(p,du,dv) nra = count(du > 0) ndec = count(dv > 0) - write(*,'(a,4es13.3)') '# solution: ',p(1:npar) - write(*,'(a,4es13.2)') '# deviations:',dp(1:npar) - write(*,'(a,2es10.2,a,g0.3,a)') '# s0,rms: ',s0,rms,' [deg] ', & - 3600*rms,' [arcsec]' - write(*,'(a,es10.2,a,g0.3,a)') '# s: ',sig,' [deg] ', & + write(error_unit,'(a,4es13.3)') '# solution: ',p(1:npar) + write(error_unit,'(a,4es13.2)') '# deviations:',dp(1:npar) + write(error_unit,'(a,es10.2,a,g0.3,a)') '# rms: ',sig,' [deg] ', & 3600*sig,' [arcsec]' - write(*,'(a,i7,"/",f0.1,2(i5,"+-",f0.1))') & + write(error_unit,'(a,i7,"/",f0.1,2(i5,"+-",f0.1))') & '# sign test (total/expected, RA+, Dec+): ',& ndat,ndat/2.0,nra,sqrt(nra*0.25),ndec,sqrt(ndec*0.25) ! simple version of sign test, var = n*p*(1-p), where p = 0.5 @@ -265,7 +274,6 @@ u(i) = x v(i) = y end if -! write(*,'(9f12.5)') u(i),v(i),x(i),y(i),3600*du,3600*dv end do end subroutine dres @@ -280,10 +288,12 @@ real(dbl), dimension(np), intent(in) :: p real(dbl), dimension(m), intent(out) :: fvec real(dbl), dimension(:), allocatable :: dx,dy,xx,yy + real(dbl), dimension(4) :: dfvec real(dbl) :: sf,sc,sx,sy,fx,fy integer :: i - if( iflag == 0 .and. debug ) write(*,*) '#robfit t:',real(p) + if( iflag == 0 .and. debug ) & + write(error_unit,*) '#robfit t:',real(p) sf = 0.0_dbl sc = 0.0_dbl @@ -295,15 +305,22 @@ do i = 1, ndat fx = tukey(dx(i)/sig) fy = tukey(dy(i)/sig) +! fx = dx(i)/sig +! fy = dy(i)/sig sx = sx + fx sy = sy + fy sc = sc + (fx*xx(i) + fy*yy(i)) sf = sf + (fx*yy(i) - fy*xx(i)) end do fvec = (/-sx,-sy,-sc,sf*p(3)/)/sig -! write(*,'(4g15.5)') fvec deallocate(dx,dy,xx,yy) + if( debug .and. .false. ) then + write(error_unit,'(a,4g15.5)') ' ',fvec * sig + call difvec(p,dfvec) + write(error_unit,'(a,4g15.5)') 'dif:',dfvec * sig + end if + end subroutine fundif @@ -319,15 +336,17 @@ real(dbl), dimension(:), allocatable :: fu,fv,dfu,dfv,du,dv,u,v,ru,rv real(dbl), dimension(m) :: fc real(dbl), dimension(4,4) :: dfjac + real(dbl), dimension(4) :: dfvec real(dbl) :: r integer :: i,j if( iflag == 0 ) then - write(*,'(4f15.5)') p + write(error_unit,'(4f15.5)') p return end if - allocate(fu(ndat),fv(ndat),du(ndat),dv(ndat),u(ndat),v(ndat),ru(ndat),rv(ndat)) + allocate(fu(ndat),fv(ndat),du(ndat),dv(ndat),u(ndat),v(ndat), & + ru(ndat),rv(ndat)) call dres(p,du,dv,u,v) r = p(3) @@ -335,17 +354,23 @@ rv = dv / sig call tukeys(ru,fu) call tukeys(rv,fv) +! fu = ru +! fv = rv - fc(1) = sum(fu) - fc(2) = sum(fv) - fc(3) = sum(fu*u + fv*v) + fc(1) =-sum(fu) + fc(2) =-sum(fv) + fc(3) =-sum(fu*u + fv*v) fc(4) = sum(fu*v - fv*u) * r if( iflag == 1 ) then - fvec(1:3) = - fc(1:3) - fvec(4) = fc(4) - fvec = fvec / sig + fvec = fc / sig + + if( debug .and. .false. ) then + write(error_unit,'(a,4g15.5)') ' ',fvec * sig + call difvec(p,dfvec) + write(error_unit,'(a,4g15.5)') 'dif:',dfvec * sig + end if else if( iflag == 2 ) then @@ -353,6 +378,8 @@ call dtukeys(ru,dfu) call dtukeys(rv,dfv) +! dfu = 1 +! dfv = 1 fjac = 0.0_dbl fjac(1,1) = sum(dfu) @@ -362,13 +389,13 @@ fjac(2,3) = sum(dfv*v) fjac(2,4) = sum(dfv*u)*r fjac(3,3) = sum(dfu*u**2 + dfv*v**2) - fjac(3,4) =-sum((dfu - dfv)*u*v)*r + fjac(3,4) = sum((dfv - dfu)*u*v)*r fjac(4,4) = sum(dfu*v**2 + dfv*u**2)*r**2 - - fjac(3,4) = fjac(3,4) + fc(4) * sig / r - fjac(4,4) = fjac(4,4) - fc(3) * sig * r fjac = fjac / sig**2 + fjac(3,4) = fjac(3,4) + fc(4) / r / sig + fjac(4,4) = fjac(4,4) - fc(3) * r / sig + do i = 1,np do j = 1,i-1 fjac(i,j) = fjac(j,i) @@ -377,11 +404,11 @@ if( debug .and. .false. ) then do i = 1,np - write(*,'(4g15.5)') fjac(i,:)*sig**2 + write(error_unit,'(4g15.5)') fjac(i,:) * sig**2 end do call difjac(p,dfjac) do i = 1,np - write(*,'(a,4g15.5)') 'dif: ',dfjac(i,:) * sig**2 + write(error_unit,'(a,4g15.5)') 'dif: ',dfjac(i,:) * sig**2 end do end if @@ -412,31 +439,61 @@ subroutine difjac(p,jac) ! numerical approximation of jacobian + ! https://en.wikipedia.org/wiki/Finite_difference real(dbl), dimension(:), intent(in) :: p real(dbl), dimension(:,:), intent(out) :: jac - real(dbl), dimension(size(p)) :: fv1, fv2, p1 + real(dbl), dimension(size(p)) :: d,fv1,fv2 integer :: i,n,iflag - real(dbl) :: d + real(dbl) :: h - iflag = 1 n = size(p) + h = sqrt(epsilon(h)) + d = 0.0_dbl + jac = 0 do i = 1, n - p1 = p if( abs(p(i)) > epsilon(p) ) then - d = sqrt(epsilon(d))*abs(p(i)) + h = sqrt(epsilon(h))*abs(p(i)) else - d = sqrt(epsilon(d)) + h = sqrt(epsilon(h)) end if - p1(i) = p(i) + d - call fundif(n,n,p1,fv1,iflag) - call fundif(n,n,p ,fv2,iflag) - jac(i,:) = (fv1 - fv2)/d + d(i) = h + call fundif(n,n,p+d,fv1,iflag) + call fundif(n,n,p-d,fv2,iflag) + jac(i,i:n) = (fv1(i:n) - fv2(i:n))/(2*h) + d(i) = 0.0_dbl end do + end subroutine difjac + subroutine difvec(p,vec) + + ! numerical approximation of jacobian + ! https://en.wikipedia.org/wiki/Finite_difference + + real(dbl), dimension(:), intent(in) :: p + real(dbl), dimension(:), intent(out) :: vec + real(dbl), dimension(size(p)) :: d + integer :: i,n + real(dbl) :: h,f1,f2 + + n = size(p) + h = sqrt(epsilon(h)) + d = 0.0_dbl + + do i = 1,n + d(i) = h + f1 = minfun(p+d) + f2 = minfun(p-d) + vec(i) = (f1 - f2)/(2*h) + d(i) = 0.0_dbl + end do + + end subroutine difvec + + function minfun(p) use rfun @@ -449,6 +506,8 @@ call dres(p,du,dv) call itukeys(du/sig,fu) call itukeys(dv/sig,fv) +! fu = (du/sig)**2 / 2 +! fv = (dv/sig)**2 / 2 minfun = sum(fu) + sum(fv) diff -Nru munipack-0.5.9/autom4te.cache/output.0 munipack-0.5.10/autom4te.cache/output.0 --- munipack-0.5.9/autom4te.cache/output.0 2017-07-17 23:04:24.000000000 +0000 +++ munipack-0.5.10/autom4te.cache/output.0 1970-01-01 00:00:00.000000000 +0000 @@ -1,7838 +0,0 @@ -@%:@! /bin/sh -@%:@ Guess values for system-dependent variables and create Makefiles. -@%:@ Generated by GNU Autoconf 2.69 for Munipack 0.5.9. -@%:@ -@%:@ Report bugs to >. -@%:@ -@%:@ -@%:@ Copyright (C) 1992-1996, 1998-2012 Free Software Foundation, Inc. -@%:@ -@%:@ -@%:@ This configure script is free software; the Free Software Foundation -@%:@ gives unlimited permission to copy, distribute and modify it. -## -------------------- ## -## M4sh Initialization. ## -## -------------------- ## - -# Be more Bourne compatible -DUALCASE=1; export DUALCASE # for MKS sh -if test -n "${ZSH_VERSION+set}" && (emulate sh) >/dev/null 2>&1; then : - emulate sh - NULLCMD=: - # Pre-4.2 versions of Zsh do word splitting on ${1+"$@"}, which - # is contrary to our usage. Disable this feature. - alias -g '${1+"$@"}'='"$@"' - setopt NO_GLOB_SUBST -else - case `(set -o) 2>/dev/null` in @%:@( - *posix*) : - set -o posix ;; @%:@( - *) : - ;; -esac -fi - - -as_nl=' -' -export as_nl -# Printing a long string crashes Solaris 7 /usr/bin/printf. -as_echo='\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\' -as_echo=$as_echo$as_echo$as_echo$as_echo$as_echo -as_echo=$as_echo$as_echo$as_echo$as_echo$as_echo$as_echo -# Prefer a ksh shell builtin over an external printf program on Solaris, -# but without wasting forks for bash or zsh. -if test -z "$BASH_VERSION$ZSH_VERSION" \ - && (test "X`print -r -- $as_echo`" = "X$as_echo") 2>/dev/null; then - as_echo='print -r --' - as_echo_n='print -rn --' -elif (test "X`printf %s $as_echo`" = "X$as_echo") 2>/dev/null; then - as_echo='printf %s\n' - as_echo_n='printf %s' -else - if test "X`(/usr/ucb/echo -n -n $as_echo) 2>/dev/null`" = "X-n $as_echo"; then - as_echo_body='eval /usr/ucb/echo -n "$1$as_nl"' - as_echo_n='/usr/ucb/echo -n' - else - as_echo_body='eval expr "X$1" : "X\\(.*\\)"' - as_echo_n_body='eval - arg=$1; - case $arg in @%:@( - *"$as_nl"*) - expr "X$arg" : "X\\(.*\\)$as_nl"; - arg=`expr "X$arg" : ".*$as_nl\\(.*\\)"`;; - esac; - expr "X$arg" : "X\\(.*\\)" | tr -d "$as_nl" - ' - export as_echo_n_body - as_echo_n='sh -c $as_echo_n_body as_echo' - fi - export as_echo_body - as_echo='sh -c $as_echo_body as_echo' -fi - -# The user is always right. -if test "${PATH_SEPARATOR+set}" != set; then - PATH_SEPARATOR=: - (PATH='/bin;/bin'; FPATH=$PATH; sh -c :) >/dev/null 2>&1 && { - (PATH='/bin:/bin'; FPATH=$PATH; sh -c :) >/dev/null 2>&1 || - PATH_SEPARATOR=';' - } -fi - - -# IFS -# We need space, tab and new line, in precisely that order. Quoting is -# there to prevent editors from complaining about space-tab. -# (If _AS_PATH_WALK were called with IFS unset, it would disable word -# splitting by setting IFS to empty value.) -IFS=" "" $as_nl" - -# Find who we are. Look in the path if we contain no directory separator. -as_myself= -case $0 in @%:@(( - *[\\/]* ) as_myself=$0 ;; - *) as_save_IFS=$IFS; IFS=$PATH_SEPARATOR -for as_dir in $PATH -do - IFS=$as_save_IFS - test -z "$as_dir" && as_dir=. - test -r "$as_dir/$0" && as_myself=$as_dir/$0 && break - done -IFS=$as_save_IFS - - ;; -esac -# We did not find ourselves, most probably we were run as `sh COMMAND' -# in which case we are not to be found in the path. -if test "x$as_myself" = x; then - as_myself=$0 -fi -if test ! -f "$as_myself"; then - $as_echo "$as_myself: error: cannot find myself; rerun with an absolute file name" >&2 - exit 1 -fi - -# Unset variables that we do not need and which cause bugs (e.g. in -# pre-3.0 UWIN ksh). But do not cause bugs in bash 2.01; the "|| exit 1" -# suppresses any "Segmentation fault" message there. '((' could -# trigger a bug in pdksh 5.2.14. -for as_var in BASH_ENV ENV MAIL MAILPATH -do eval test x\${$as_var+set} = xset \ - && ( (unset $as_var) || exit 1) >/dev/null 2>&1 && unset $as_var || : -done -PS1='$ ' -PS2='> ' -PS4='+ ' - -# NLS nuisances. -LC_ALL=C -export LC_ALL -LANGUAGE=C -export LANGUAGE - -# CDPATH. -(unset CDPATH) >/dev/null 2>&1 && unset CDPATH - -# Use a proper internal environment variable to ensure we don't fall - # into an infinite loop, continuously re-executing ourselves. - if test x"${_as_can_reexec}" != xno && test "x$CONFIG_SHELL" != x; then - _as_can_reexec=no; export _as_can_reexec; - # We cannot yet assume a decent shell, so we have to provide a -# neutralization value for shells without unset; and this also -# works around shells that cannot unset nonexistent variables. -# Preserve -v and -x to the replacement shell. -BASH_ENV=/dev/null -ENV=/dev/null -(unset BASH_ENV) >/dev/null 2>&1 && unset BASH_ENV ENV -case $- in @%:@ (((( - *v*x* | *x*v* ) as_opts=-vx ;; - *v* ) as_opts=-v ;; - *x* ) as_opts=-x ;; - * ) as_opts= ;; -esac -exec $CONFIG_SHELL $as_opts "$as_myself" ${1+"$@"} -# Admittedly, this is quite paranoid, since all the known shells bail -# out after a failed `exec'. -$as_echo "$0: could not re-execute with $CONFIG_SHELL" >&2 -as_fn_exit 255 - fi - # We don't want this to propagate to other subprocesses. - { _as_can_reexec=; unset _as_can_reexec;} -if test "x$CONFIG_SHELL" = x; then - as_bourne_compatible="if test -n \"\${ZSH_VERSION+set}\" && (emulate sh) >/dev/null 2>&1; then : - emulate sh - NULLCMD=: - # Pre-4.2 versions of Zsh do word splitting on \${1+\"\$@\"}, which - # is contrary to our usage. Disable this feature. - alias -g '\${1+\"\$@\"}'='\"\$@\"' - setopt NO_GLOB_SUBST -else - case \`(set -o) 2>/dev/null\` in @%:@( - *posix*) : - set -o posix ;; @%:@( - *) : - ;; -esac -fi -" - as_required="as_fn_return () { (exit \$1); } -as_fn_success () { as_fn_return 0; } -as_fn_failure () { as_fn_return 1; } -as_fn_ret_success () { return 0; } -as_fn_ret_failure () { return 1; } - -exitcode=0 -as_fn_success || { exitcode=1; echo as_fn_success failed.; } -as_fn_failure && { exitcode=1; echo as_fn_failure succeeded.; } -as_fn_ret_success || { exitcode=1; echo as_fn_ret_success failed.; } -as_fn_ret_failure && { exitcode=1; echo as_fn_ret_failure succeeded.; } -if ( set x; as_fn_ret_success y && test x = \"\$1\" ); then : - -else - exitcode=1; echo positional parameters were not saved. -fi -test x\$exitcode = x0 || exit 1 -test -x / || exit 1" - as_suggested=" as_lineno_1=";as_suggested=$as_suggested$LINENO;as_suggested=$as_suggested" as_lineno_1a=\$LINENO - as_lineno_2=";as_suggested=$as_suggested$LINENO;as_suggested=$as_suggested" as_lineno_2a=\$LINENO - eval 'test \"x\$as_lineno_1'\$as_run'\" != \"x\$as_lineno_2'\$as_run'\" && - test \"x\`expr \$as_lineno_1'\$as_run' + 1\`\" = \"x\$as_lineno_2'\$as_run'\"' || exit 1 -test \$(( 1 + 1 )) = 2 || exit 1" - if (eval "$as_required") 2>/dev/null; then : - as_have_required=yes -else - as_have_required=no -fi - if test x$as_have_required = xyes && (eval "$as_suggested") 2>/dev/null; then : - -else - as_save_IFS=$IFS; IFS=$PATH_SEPARATOR -as_found=false -for as_dir in /bin$PATH_SEPARATOR/usr/bin$PATH_SEPARATOR$PATH -do - IFS=$as_save_IFS - test -z "$as_dir" && as_dir=. - as_found=: - case $as_dir in @%:@( - /*) - for as_base in sh bash ksh sh5; do - # Try only shells that exist, to save several forks. - as_shell=$as_dir/$as_base - if { test -f "$as_shell" || test -f "$as_shell.exe"; } && - { $as_echo "$as_bourne_compatible""$as_required" | as_run=a "$as_shell"; } 2>/dev/null; then : - CONFIG_SHELL=$as_shell as_have_required=yes - if { $as_echo "$as_bourne_compatible""$as_suggested" | as_run=a "$as_shell"; } 2>/dev/null; then : - break 2 -fi -fi - done;; - esac - as_found=false -done -$as_found || { if { test -f "$SHELL" || test -f "$SHELL.exe"; } && - { $as_echo "$as_bourne_compatible""$as_required" | as_run=a "$SHELL"; } 2>/dev/null; then : - CONFIG_SHELL=$SHELL as_have_required=yes -fi; } -IFS=$as_save_IFS - - - if test "x$CONFIG_SHELL" != x; then : - export CONFIG_SHELL - # We cannot yet assume a decent shell, so we have to provide a -# neutralization value for shells without unset; and this also -# works around shells that cannot unset nonexistent variables. -# Preserve -v and -x to the replacement shell. -BASH_ENV=/dev/null -ENV=/dev/null -(unset BASH_ENV) >/dev/null 2>&1 && unset BASH_ENV ENV -case $- in @%:@ (((( - *v*x* | *x*v* ) as_opts=-vx ;; - *v* ) as_opts=-v ;; - *x* ) as_opts=-x ;; - * ) as_opts= ;; -esac -exec $CONFIG_SHELL $as_opts "$as_myself" ${1+"$@"} -# Admittedly, this is quite paranoid, since all the known shells bail -# out after a failed `exec'. -$as_echo "$0: could not re-execute with $CONFIG_SHELL" >&2 -exit 255 -fi - - if test x$as_have_required = xno; then : - $as_echo "$0: This script requires a shell more modern than all" - $as_echo "$0: the shells that I found on your system." - if test x${ZSH_VERSION+set} = xset ; then - $as_echo "$0: In particular, zsh $ZSH_VERSION has bugs and should" - $as_echo "$0: be upgraded to zsh 4.3.4 or later." - else - $as_echo "$0: Please tell bug-autoconf@gnu.org and Filip Hroch -$0: about your system, including -$0: any error possibly output before this message. Then -$0: install a modern shell, or manually run the script -$0: under such a shell if you do have one." - fi - exit 1 -fi -fi -fi -SHELL=${CONFIG_SHELL-/bin/sh} -export SHELL -# Unset more variables known to interfere with behavior of common tools. -CLICOLOR_FORCE= GREP_OPTIONS= -unset CLICOLOR_FORCE GREP_OPTIONS - -## --------------------- ## -## M4sh Shell Functions. ## -## --------------------- ## -@%:@ as_fn_unset VAR -@%:@ --------------- -@%:@ Portably unset VAR. -as_fn_unset () -{ - { eval $1=; unset $1;} -} -as_unset=as_fn_unset - -@%:@ as_fn_set_status STATUS -@%:@ ----------------------- -@%:@ Set @S|@? to STATUS, without forking. -as_fn_set_status () -{ - return $1 -} @%:@ as_fn_set_status - -@%:@ as_fn_exit STATUS -@%:@ ----------------- -@%:@ Exit the shell with STATUS, even in a "trap 0" or "set -e" context. -as_fn_exit () -{ - set +e - as_fn_set_status $1 - exit $1 -} @%:@ as_fn_exit - -@%:@ as_fn_mkdir_p -@%:@ ------------- -@%:@ Create "@S|@as_dir" as a directory, including parents if necessary. -as_fn_mkdir_p () -{ - - case $as_dir in #( - -*) as_dir=./$as_dir;; - esac - test -d "$as_dir" || eval $as_mkdir_p || { - as_dirs= - while :; do - case $as_dir in #( - *\'*) as_qdir=`$as_echo "$as_dir" | sed "s/'/'\\\\\\\\''/g"`;; #'( - *) as_qdir=$as_dir;; - esac - as_dirs="'$as_qdir' $as_dirs" - as_dir=`$as_dirname -- "$as_dir" || -$as_expr X"$as_dir" : 'X\(.*[^/]\)//*[^/][^/]*/*$' \| \ - X"$as_dir" : 'X\(//\)[^/]' \| \ - X"$as_dir" : 'X\(//\)$' \| \ - X"$as_dir" : 'X\(/\)' \| . 2>/dev/null || -$as_echo X"$as_dir" | - sed '/^X\(.*[^/]\)\/\/*[^/][^/]*\/*$/{ - s//\1/ - q - } - /^X\(\/\/\)[^/].*/{ - s//\1/ - q - } - /^X\(\/\/\)$/{ - s//\1/ - q - } - /^X\(\/\).*/{ - s//\1/ - q - } - s/.*/./; q'` - test -d "$as_dir" && break - done - test -z "$as_dirs" || eval "mkdir $as_dirs" - } || test -d "$as_dir" || as_fn_error $? "cannot create directory $as_dir" - - -} @%:@ as_fn_mkdir_p - -@%:@ as_fn_executable_p FILE -@%:@ ----------------------- -@%:@ Test if FILE is an executable regular file. -as_fn_executable_p () -{ - test -f "$1" && test -x "$1" -} @%:@ as_fn_executable_p -@%:@ as_fn_append VAR VALUE -@%:@ ---------------------- -@%:@ Append the text in VALUE to the end of the definition contained in VAR. Take -@%:@ advantage of any shell optimizations that allow amortized linear growth over -@%:@ repeated appends, instead of the typical quadratic growth present in naive -@%:@ implementations. -if (eval "as_var=1; as_var+=2; test x\$as_var = x12") 2>/dev/null; then : - eval 'as_fn_append () - { - eval $1+=\$2 - }' -else - as_fn_append () - { - eval $1=\$$1\$2 - } -fi # as_fn_append - -@%:@ as_fn_arith ARG... -@%:@ ------------------ -@%:@ Perform arithmetic evaluation on the ARGs, and store the result in the -@%:@ global @S|@as_val. Take advantage of shells that can avoid forks. The arguments -@%:@ must be portable across @S|@(()) and expr. -if (eval "test \$(( 1 + 1 )) = 2") 2>/dev/null; then : - eval 'as_fn_arith () - { - as_val=$(( $* )) - }' -else - as_fn_arith () - { - as_val=`expr "$@" || test $? -eq 1` - } -fi # as_fn_arith - - -@%:@ as_fn_error STATUS ERROR [LINENO LOG_FD] -@%:@ ---------------------------------------- -@%:@ Output "`basename @S|@0`: error: ERROR" to stderr. If LINENO and LOG_FD are -@%:@ provided, also output the error to LOG_FD, referencing LINENO. Then exit the -@%:@ script with STATUS, using 1 if that was 0. -as_fn_error () -{ - as_status=$1; test $as_status -eq 0 && as_status=1 - if test "$4"; then - as_lineno=${as_lineno-"$3"} as_lineno_stack=as_lineno_stack=$as_lineno_stack - $as_echo "$as_me:${as_lineno-$LINENO}: error: $2" >&$4 - fi - $as_echo "$as_me: error: $2" >&2 - as_fn_exit $as_status -} @%:@ as_fn_error - -if expr a : '\(a\)' >/dev/null 2>&1 && - test "X`expr 00001 : '.*\(...\)'`" = X001; then - as_expr=expr -else - as_expr=false -fi - -if (basename -- /) >/dev/null 2>&1 && test "X`basename -- / 2>&1`" = "X/"; then - as_basename=basename -else - as_basename=false -fi - -if (as_dir=`dirname -- /` && test "X$as_dir" = X/) >/dev/null 2>&1; then - as_dirname=dirname -else - as_dirname=false -fi - -as_me=`$as_basename -- "$0" || -$as_expr X/"$0" : '.*/\([^/][^/]*\)/*$' \| \ - X"$0" : 'X\(//\)$' \| \ - X"$0" : 'X\(/\)' \| . 2>/dev/null || -$as_echo X/"$0" | - sed '/^.*\/\([^/][^/]*\)\/*$/{ - s//\1/ - q - } - /^X\/\(\/\/\)$/{ - s//\1/ - q - } - /^X\/\(\/\).*/{ - s//\1/ - q - } - s/.*/./; q'` - -# Avoid depending upon Character Ranges. -as_cr_letters='abcdefghijklmnopqrstuvwxyz' -as_cr_LETTERS='ABCDEFGHIJKLMNOPQRSTUVWXYZ' -as_cr_Letters=$as_cr_letters$as_cr_LETTERS -as_cr_digits='0123456789' -as_cr_alnum=$as_cr_Letters$as_cr_digits - - - as_lineno_1=$LINENO as_lineno_1a=$LINENO - as_lineno_2=$LINENO as_lineno_2a=$LINENO - eval 'test "x$as_lineno_1'$as_run'" != "x$as_lineno_2'$as_run'" && - test "x`expr $as_lineno_1'$as_run' + 1`" = "x$as_lineno_2'$as_run'"' || { - # Blame Lee E. McMahon (1931-1989) for sed's syntax. :-) - sed -n ' - p - /[$]LINENO/= - ' <$as_myself | - sed ' - s/[$]LINENO.*/&-/ - t lineno - b - :lineno - N - :loop - s/[$]LINENO\([^'$as_cr_alnum'_].*\n\)\(.*\)/\2\1\2/ - t loop - s/-\n.*// - ' >$as_me.lineno && - chmod +x "$as_me.lineno" || - { $as_echo "$as_me: error: cannot create $as_me.lineno; rerun with a POSIX shell" >&2; as_fn_exit 1; } - - # If we had to re-execute with $CONFIG_SHELL, we're ensured to have - # already done that, so ensure we don't try to do so again and fall - # in an infinite loop. This has already happened in practice. - _as_can_reexec=no; export _as_can_reexec - # Don't try to exec as it changes $[0], causing all sort of problems - # (the dirname of $[0] is not the place where we might find the - # original and so on. Autoconf is especially sensitive to this). - . "./$as_me.lineno" - # Exit status is that of the last command. - exit -} - -ECHO_C= ECHO_N= ECHO_T= -case `echo -n x` in @%:@((((( --n*) - case `echo 'xy\c'` in - *c*) ECHO_T=' ';; # ECHO_T is single tab character. - xy) ECHO_C='\c';; - *) echo `echo ksh88 bug on AIX 6.1` > /dev/null - ECHO_T=' ';; - esac;; -*) - ECHO_N='-n';; -esac - -rm -f conf$$ conf$$.exe conf$$.file -if test -d conf$$.dir; then - rm -f conf$$.dir/conf$$.file -else - rm -f conf$$.dir - mkdir conf$$.dir 2>/dev/null -fi -if (echo >conf$$.file) 2>/dev/null; then - if ln -s conf$$.file conf$$ 2>/dev/null; then - as_ln_s='ln -s' - # ... but there are two gotchas: - # 1) On MSYS, both `ln -s file dir' and `ln file dir' fail. - # 2) DJGPP < 2.04 has no symlinks; `ln -s' creates a wrapper executable. - # In both cases, we have to default to `cp -pR'. - ln -s conf$$.file conf$$.dir 2>/dev/null && test ! -f conf$$.exe || - as_ln_s='cp -pR' - elif ln conf$$.file conf$$ 2>/dev/null; then - as_ln_s=ln - else - as_ln_s='cp -pR' - fi -else - as_ln_s='cp -pR' -fi -rm -f conf$$ conf$$.exe conf$$.dir/conf$$.file conf$$.file -rmdir conf$$.dir 2>/dev/null - -if mkdir -p . 2>/dev/null; then - as_mkdir_p='mkdir -p "$as_dir"' -else - test -d ./-p && rmdir ./-p - as_mkdir_p=false -fi - -as_test_x='test -x' -as_executable_p=as_fn_executable_p - -# Sed expression to map a string onto a valid CPP name. -as_tr_cpp="eval sed 'y%*$as_cr_letters%P$as_cr_LETTERS%;s%[^_$as_cr_alnum]%_%g'" - -# Sed expression to map a string onto a valid variable name. -as_tr_sh="eval sed 'y%*+%pp%;s%[^_$as_cr_alnum]%_%g'" - - -test -n "$DJDIR" || exec 7<&0 &1 - -# Name of the host. -# hostname on some systems (SVR3.2, old GNU/Linux) returns a bogus exit status, -# so uname gets run too. -ac_hostname=`(hostname || uname -n) 2>/dev/null | sed 1q` - -# -# Initializations. -# -ac_default_prefix=/usr/local -ac_clean_files= -ac_config_libobj_dir=. -LIB@&t@OBJS= -cross_compiling=no -subdirs= -MFLAGS= -MAKEFLAGS= - -# Identity of this package. -PACKAGE_NAME='Munipack' -PACKAGE_TARNAME='munipack' -PACKAGE_VERSION='0.5.9' -PACKAGE_STRING='Munipack 0.5.9' -PACKAGE_BUGREPORT='Filip Hroch ' -PACKAGE_URL='http://munipack.physics.muni.cz' - -# Factoring default headers for most tests. -ac_includes_default="\ -#include -#ifdef HAVE_SYS_TYPES_H -# include -#endif -#ifdef HAVE_SYS_STAT_H -# include -#endif -#ifdef STDC_HEADERS -# include -# include -#else -# ifdef HAVE_STDLIB_H -# include -# endif -#endif -#ifdef HAVE_STRING_H -# if !defined STDC_HEADERS && defined HAVE_MEMORY_H -# include -# endif -# include -#endif -#ifdef HAVE_STRINGS_H -# include -#endif -#ifdef HAVE_INTTYPES_H -# include -#endif -#ifdef HAVE_STDINT_H -# include -#endif -#ifdef HAVE_UNISTD_H -# include -#endif" - -ac_subst_vars='am__EXEEXT_FALSE -am__EXEEXT_TRUE -LTLIBOBJS -CLEANFILES -LIBSTDCPP -LIBGCC -LIBGFORTRAN -BUNDLEDIR -BUNDLE_FALSE -BUNDLE_TRUE -VODIR -WX_CXXFLAGS_VO -WX_LIBS_VO -WX_LIBS_CLI -WX_CXXFLAGS_CLI -MUNIPACKDIR -MATPLOTDIR -XMUNIPACKDIR -WX_VERSION_MICRO -WX_VERSION_MINOR -WX_VERSION_MAJOR -WX_RESCOMP -WX_VERSION -WX_LIBS_STATIC -WX_LIBS -WX_CXXFLAGS_ONLY -WX_CFLAGS_ONLY -WX_CXXFLAGS -WX_CFLAGS -WX_CPPFLAGS -WX_CONFIG_PATH -LDMINPACK -MINPACKDIR -ac_ct_F77 -FFLAGS -F77 -LIBCFITSIO -FC_MODEXT -FC_MODOUT -ac_empty -FC_MODINC -LIB@&t@OBJS -EGREP -GREP -LN_S -RANLIB -ac_ct_FC -FCFLAGS -FC -CPP -am__fastdepCXX_FALSE -am__fastdepCXX_TRUE -CXXDEPMODE -ac_ct_CXX -CXXFLAGS -CXX -am__fastdepCC_FALSE -am__fastdepCC_TRUE -CCDEPMODE -am__nodep -AMDEPBACKSLASH -AMDEP_FALSE -AMDEP_TRUE -am__quote -am__include -DEPDIR -OBJEXT -EXEEXT -ac_ct_CC -CPPFLAGS -LDFLAGS -CFLAGS -CC -AM_BACKSLASH -AM_DEFAULT_VERBOSITY -AM_DEFAULT_V -AM_V -am__untar -am__tar -AMTAR -am__leading_dot -SET_MAKE -AWK -mkdir_p -MKDIR_P -INSTALL_STRIP_PROGRAM -STRIP -install_sh -MAKEINFO -AUTOHEADER -AUTOMAKE -AUTOCONF -ACLOCAL -VERSION -PACKAGE -CYGPATH_W -am__isrc -INSTALL_DATA -INSTALL_SCRIPT -INSTALL_PROGRAM -build_os -build_vendor -build_cpu -build -develop -target_alias -host_alias -build_alias -LIBS -ECHO_T -ECHO_N -ECHO_C -DEFS -mandir -localedir -libdir -psdir -pdfdir -dvidir -htmldir -infodir -docdir -oldincludedir -includedir -runstatedir -localstatedir -sharedstatedir -sysconfdir -datadir -datarootdir -libexecdir -sbindir -bindir -program_transform_name -prefix -exec_prefix -PACKAGE_URL -PACKAGE_BUGREPORT -PACKAGE_STRING -PACKAGE_VERSION -PACKAGE_TARNAME -PACKAGE_NAME -PATH_SEPARATOR -SHELL' -ac_subst_files='' -ac_user_opts=' -enable_option_checking -enable_silent_rules -enable_dependency_tracking -enable_vo -enable_cli -enable_gui -with_wxdir -with_wx_config -with_wx_prefix -with_wx_exec_prefix -enable_bundle -' - ac_precious_vars='build_alias -host_alias -target_alias -CC -CFLAGS -LDFLAGS -LIBS -CPPFLAGS -CXX -CXXFLAGS -CCC -CPP -FC -FCFLAGS -F77 -FFLAGS -BUNDLEDIR' - - -# Initialize some variables set by options. -ac_init_help= -ac_init_version=false -ac_unrecognized_opts= -ac_unrecognized_sep= -# The variables have the same names as the options, with -# dashes changed to underlines. -cache_file=/dev/null -exec_prefix=NONE -no_create= -no_recursion= -prefix=NONE -program_prefix=NONE -program_suffix=NONE -program_transform_name=s,x,x, -silent= -site= -srcdir= -verbose= -x_includes=NONE -x_libraries=NONE - -# Installation directory options. -# These are left unexpanded so users can "make install exec_prefix=/foo" -# and all the variables that are supposed to be based on exec_prefix -# by default will actually change. -# Use braces instead of parens because sh, perl, etc. also accept them. -# (The list follows the same order as the GNU Coding Standards.) -bindir='${exec_prefix}/bin' -sbindir='${exec_prefix}/sbin' -libexecdir='${exec_prefix}/libexec' -datarootdir='${prefix}/share' -datadir='${datarootdir}' -sysconfdir='${prefix}/etc' -sharedstatedir='${prefix}/com' -localstatedir='${prefix}/var' -runstatedir='${localstatedir}/run' -includedir='${prefix}/include' -oldincludedir='/usr/include' -docdir='${datarootdir}/doc/${PACKAGE_TARNAME}' -infodir='${datarootdir}/info' -htmldir='${docdir}' -dvidir='${docdir}' -pdfdir='${docdir}' -psdir='${docdir}' -libdir='${exec_prefix}/lib' -localedir='${datarootdir}/locale' -mandir='${datarootdir}/man' - -ac_prev= -ac_dashdash= -for ac_option -do - # If the previous option needs an argument, assign it. - if test -n "$ac_prev"; then - eval $ac_prev=\$ac_option - ac_prev= - continue - fi - - case $ac_option in - *=?*) ac_optarg=`expr "X$ac_option" : '[^=]*=\(.*\)'` ;; - *=) ac_optarg= ;; - *) ac_optarg=yes ;; - esac - - # Accept the important Cygnus configure options, so we can diagnose typos. - - case $ac_dashdash$ac_option in - --) - ac_dashdash=yes ;; - - -bindir | --bindir | --bindi | --bind | --bin | --bi) - ac_prev=bindir ;; - -bindir=* | --bindir=* | --bindi=* | --bind=* | --bin=* | --bi=*) - bindir=$ac_optarg ;; - - -build | --build | --buil | --bui | --bu) - ac_prev=build_alias ;; - -build=* | --build=* | --buil=* | --bui=* | --bu=*) - build_alias=$ac_optarg ;; - - -cache-file | --cache-file | --cache-fil | --cache-fi \ - | --cache-f | --cache- | --cache | --cach | --cac | --ca | --c) - ac_prev=cache_file ;; - -cache-file=* | --cache-file=* | --cache-fil=* | --cache-fi=* \ - | --cache-f=* | --cache-=* | --cache=* | --cach=* | --cac=* | --ca=* | --c=*) - cache_file=$ac_optarg ;; - - --config-cache | -C) - cache_file=config.cache ;; - - -datadir | --datadir | --datadi | --datad) - ac_prev=datadir ;; - -datadir=* | --datadir=* | --datadi=* | --datad=*) - datadir=$ac_optarg ;; - - -datarootdir | --datarootdir | --datarootdi | --datarootd | --dataroot \ - | --dataroo | --dataro | --datar) - ac_prev=datarootdir ;; - -datarootdir=* | --datarootdir=* | --datarootdi=* | --datarootd=* \ - | --dataroot=* | --dataroo=* | --dataro=* | --datar=*) - datarootdir=$ac_optarg ;; - - -disable-* | --disable-*) - ac_useropt=`expr "x$ac_option" : 'x-*disable-\(.*\)'` - # Reject names that are not valid shell variable names. - expr "x$ac_useropt" : ".*[^-+._$as_cr_alnum]" >/dev/null && - as_fn_error $? "invalid feature name: $ac_useropt" - ac_useropt_orig=$ac_useropt - ac_useropt=`$as_echo "$ac_useropt" | sed 's/[-+.]/_/g'` - case $ac_user_opts in - *" -"enable_$ac_useropt" -"*) ;; - *) ac_unrecognized_opts="$ac_unrecognized_opts$ac_unrecognized_sep--disable-$ac_useropt_orig" - ac_unrecognized_sep=', ';; - esac - eval enable_$ac_useropt=no ;; - - -docdir | --docdir | --docdi | --doc | --do) - ac_prev=docdir ;; - -docdir=* | --docdir=* | --docdi=* | --doc=* | --do=*) - docdir=$ac_optarg ;; - - -dvidir | --dvidir | --dvidi | --dvid | --dvi | --dv) - ac_prev=dvidir ;; - -dvidir=* | --dvidir=* | --dvidi=* | --dvid=* | --dvi=* | --dv=*) - dvidir=$ac_optarg ;; - - -enable-* | --enable-*) - ac_useropt=`expr "x$ac_option" : 'x-*enable-\([^=]*\)'` - # Reject names that are not valid shell variable names. - expr "x$ac_useropt" : ".*[^-+._$as_cr_alnum]" >/dev/null && - as_fn_error $? "invalid feature name: $ac_useropt" - ac_useropt_orig=$ac_useropt - ac_useropt=`$as_echo "$ac_useropt" | sed 's/[-+.]/_/g'` - case $ac_user_opts in - *" -"enable_$ac_useropt" -"*) ;; - *) ac_unrecognized_opts="$ac_unrecognized_opts$ac_unrecognized_sep--enable-$ac_useropt_orig" - ac_unrecognized_sep=', ';; - esac - eval enable_$ac_useropt=\$ac_optarg ;; - - -exec-prefix | --exec_prefix | --exec-prefix | --exec-prefi \ - | --exec-pref | --exec-pre | --exec-pr | --exec-p | --exec- \ - | --exec | --exe | --ex) - ac_prev=exec_prefix ;; - -exec-prefix=* | --exec_prefix=* | --exec-prefix=* | --exec-prefi=* \ - | --exec-pref=* | --exec-pre=* | --exec-pr=* | --exec-p=* | --exec-=* \ - | --exec=* | --exe=* | --ex=*) - exec_prefix=$ac_optarg ;; - - -gas | --gas | --ga | --g) - # Obsolete; use --with-gas. - with_gas=yes ;; - - -help | --help | --hel | --he | -h) - ac_init_help=long ;; - -help=r* | --help=r* | --hel=r* | --he=r* | -hr*) - ac_init_help=recursive ;; - -help=s* | --help=s* | --hel=s* | --he=s* | -hs*) - ac_init_help=short ;; - - -host | --host | --hos | --ho) - ac_prev=host_alias ;; - -host=* | --host=* | --hos=* | --ho=*) - host_alias=$ac_optarg ;; - - -htmldir | --htmldir | --htmldi | --htmld | --html | --htm | --ht) - ac_prev=htmldir ;; - -htmldir=* | --htmldir=* | --htmldi=* | --htmld=* | --html=* | --htm=* \ - | --ht=*) - htmldir=$ac_optarg ;; - - -includedir | --includedir | --includedi | --included | --include \ - | --includ | --inclu | --incl | --inc) - ac_prev=includedir ;; - -includedir=* | --includedir=* | --includedi=* | --included=* | --include=* \ - | --includ=* | --inclu=* | --incl=* | --inc=*) - includedir=$ac_optarg ;; - - -infodir | --infodir | --infodi | --infod | --info | --inf) - ac_prev=infodir ;; - -infodir=* | --infodir=* | --infodi=* | --infod=* | --info=* | --inf=*) - infodir=$ac_optarg ;; - - -libdir | --libdir | --libdi | --libd) - ac_prev=libdir ;; - -libdir=* | --libdir=* | --libdi=* | --libd=*) - libdir=$ac_optarg ;; - - -libexecdir | --libexecdir | --libexecdi | --libexecd | --libexec \ - | --libexe | --libex | --libe) - ac_prev=libexecdir ;; - -libexecdir=* | --libexecdir=* | --libexecdi=* | --libexecd=* | --libexec=* \ - | --libexe=* | --libex=* | --libe=*) - libexecdir=$ac_optarg ;; - - -localedir | --localedir | --localedi | --localed | --locale) - ac_prev=localedir ;; - -localedir=* | --localedir=* | --localedi=* | --localed=* | --locale=*) - localedir=$ac_optarg ;; - - -localstatedir | --localstatedir | --localstatedi | --localstated \ - | --localstate | --localstat | --localsta | --localst | --locals) - ac_prev=localstatedir ;; - -localstatedir=* | --localstatedir=* | --localstatedi=* | --localstated=* \ - | --localstate=* | --localstat=* | --localsta=* | --localst=* | --locals=*) - localstatedir=$ac_optarg ;; - - -mandir | --mandir | --mandi | --mand | --man | --ma | --m) - ac_prev=mandir ;; - -mandir=* | --mandir=* | --mandi=* | --mand=* | --man=* | --ma=* | --m=*) - mandir=$ac_optarg ;; - - -nfp | --nfp | --nf) - # Obsolete; use --without-fp. - with_fp=no ;; - - -no-create | --no-create | --no-creat | --no-crea | --no-cre \ - | --no-cr | --no-c | -n) - no_create=yes ;; - - -no-recursion | --no-recursion | --no-recursio | --no-recursi \ - | --no-recurs | --no-recur | --no-recu | --no-rec | --no-re | --no-r) - no_recursion=yes ;; - - -oldincludedir | --oldincludedir | --oldincludedi | --oldincluded \ - | --oldinclude | --oldinclud | --oldinclu | --oldincl | --oldinc \ - | --oldin | --oldi | --old | --ol | --o) - ac_prev=oldincludedir ;; - -oldincludedir=* | --oldincludedir=* | --oldincludedi=* | --oldincluded=* \ - | --oldinclude=* | --oldinclud=* | --oldinclu=* | --oldincl=* | --oldinc=* \ - | --oldin=* | --oldi=* | --old=* | --ol=* | --o=*) - oldincludedir=$ac_optarg ;; - - -prefix | --prefix | --prefi | --pref | --pre | --pr | --p) - ac_prev=prefix ;; - -prefix=* | --prefix=* | --prefi=* | --pref=* | --pre=* | --pr=* | --p=*) - prefix=$ac_optarg ;; - - -program-prefix | --program-prefix | --program-prefi | --program-pref \ - | --program-pre | --program-pr | --program-p) - ac_prev=program_prefix ;; - -program-prefix=* | --program-prefix=* | --program-prefi=* \ - | --program-pref=* | --program-pre=* | --program-pr=* | --program-p=*) - program_prefix=$ac_optarg ;; - - -program-suffix | --program-suffix | --program-suffi | --program-suff \ - | --program-suf | --program-su | --program-s) - ac_prev=program_suffix ;; - -program-suffix=* | --program-suffix=* | --program-suffi=* \ - | --program-suff=* | --program-suf=* | --program-su=* | --program-s=*) - program_suffix=$ac_optarg ;; - - -program-transform-name | --program-transform-name \ - | --program-transform-nam | --program-transform-na \ - | --program-transform-n | --program-transform- \ - | --program-transform | --program-transfor \ - | --program-transfo | --program-transf \ - | --program-trans | --program-tran \ - | --progr-tra | --program-tr | --program-t) - ac_prev=program_transform_name ;; - -program-transform-name=* | --program-transform-name=* \ - | --program-transform-nam=* | --program-transform-na=* \ - | --program-transform-n=* | --program-transform-=* \ - | --program-transform=* | --program-transfor=* \ - | --program-transfo=* | --program-transf=* \ - | --program-trans=* | --program-tran=* \ - | --progr-tra=* | --program-tr=* | --program-t=*) - program_transform_name=$ac_optarg ;; - - -pdfdir | --pdfdir | --pdfdi | --pdfd | --pdf | --pd) - ac_prev=pdfdir ;; - -pdfdir=* | --pdfdir=* | --pdfdi=* | --pdfd=* | --pdf=* | --pd=*) - pdfdir=$ac_optarg ;; - - -psdir | --psdir | --psdi | --psd | --ps) - ac_prev=psdir ;; - -psdir=* | --psdir=* | --psdi=* | --psd=* | --ps=*) - psdir=$ac_optarg ;; - - -q | -quiet | --quiet | --quie | --qui | --qu | --q \ - | -silent | --silent | --silen | --sile | --sil) - silent=yes ;; - - -runstatedir | --runstatedir | --runstatedi | --runstated \ - | --runstate | --runstat | --runsta | --runst | --runs \ - | --run | --ru | --r) - ac_prev=runstatedir ;; - -runstatedir=* | --runstatedir=* | --runstatedi=* | --runstated=* \ - | --runstate=* | --runstat=* | --runsta=* | --runst=* | --runs=* \ - | --run=* | --ru=* | --r=*) - runstatedir=$ac_optarg ;; - - -sbindir | --sbindir | --sbindi | --sbind | --sbin | --sbi | --sb) - ac_prev=sbindir ;; - -sbindir=* | --sbindir=* | --sbindi=* | --sbind=* | --sbin=* \ - | --sbi=* | --sb=*) - sbindir=$ac_optarg ;; - - -sharedstatedir | --sharedstatedir | --sharedstatedi \ - | --sharedstated | --sharedstate | --sharedstat | --sharedsta \ - | --sharedst | --shareds | --shared | --share | --shar \ - | --sha | --sh) - ac_prev=sharedstatedir ;; - -sharedstatedir=* | --sharedstatedir=* | --sharedstatedi=* \ - | --sharedstated=* | --sharedstate=* | --sharedstat=* | --sharedsta=* \ - | --sharedst=* | --shareds=* | --shared=* | --share=* | --shar=* \ - | --sha=* | --sh=*) - sharedstatedir=$ac_optarg ;; - - -site | --site | --sit) - ac_prev=site ;; - -site=* | --site=* | --sit=*) - site=$ac_optarg ;; - - -srcdir | --srcdir | --srcdi | --srcd | --src | --sr) - ac_prev=srcdir ;; - -srcdir=* | --srcdir=* | --srcdi=* | --srcd=* | --src=* | --sr=*) - srcdir=$ac_optarg ;; - - -sysconfdir | --sysconfdir | --sysconfdi | --sysconfd | --sysconf \ - | --syscon | --sysco | --sysc | --sys | --sy) - ac_prev=sysconfdir ;; - -sysconfdir=* | --sysconfdir=* | --sysconfdi=* | --sysconfd=* | --sysconf=* \ - | --syscon=* | --sysco=* | --sysc=* | --sys=* | --sy=*) - sysconfdir=$ac_optarg ;; - - -target | --target | --targe | --targ | --tar | --ta | --t) - ac_prev=target_alias ;; - -target=* | --target=* | --targe=* | --targ=* | --tar=* | --ta=* | --t=*) - target_alias=$ac_optarg ;; - - -v | -verbose | --verbose | --verbos | --verbo | --verb) - verbose=yes ;; - - -version | --version | --versio | --versi | --vers | -V) - ac_init_version=: ;; - - -with-* | --with-*) - ac_useropt=`expr "x$ac_option" : 'x-*with-\([^=]*\)'` - # Reject names that are not valid shell variable names. - expr "x$ac_useropt" : ".*[^-+._$as_cr_alnum]" >/dev/null && - as_fn_error $? "invalid package name: $ac_useropt" - ac_useropt_orig=$ac_useropt - ac_useropt=`$as_echo "$ac_useropt" | sed 's/[-+.]/_/g'` - case $ac_user_opts in - *" -"with_$ac_useropt" -"*) ;; - *) ac_unrecognized_opts="$ac_unrecognized_opts$ac_unrecognized_sep--with-$ac_useropt_orig" - ac_unrecognized_sep=', ';; - esac - eval with_$ac_useropt=\$ac_optarg ;; - - -without-* | --without-*) - ac_useropt=`expr "x$ac_option" : 'x-*without-\(.*\)'` - # Reject names that are not valid shell variable names. - expr "x$ac_useropt" : ".*[^-+._$as_cr_alnum]" >/dev/null && - as_fn_error $? "invalid package name: $ac_useropt" - ac_useropt_orig=$ac_useropt - ac_useropt=`$as_echo "$ac_useropt" | sed 's/[-+.]/_/g'` - case $ac_user_opts in - *" -"with_$ac_useropt" -"*) ;; - *) ac_unrecognized_opts="$ac_unrecognized_opts$ac_unrecognized_sep--without-$ac_useropt_orig" - ac_unrecognized_sep=', ';; - esac - eval with_$ac_useropt=no ;; - - --x) - # Obsolete; use --with-x. - with_x=yes ;; - - -x-includes | --x-includes | --x-include | --x-includ | --x-inclu \ - | --x-incl | --x-inc | --x-in | --x-i) - ac_prev=x_includes ;; - -x-includes=* | --x-includes=* | --x-include=* | --x-includ=* | --x-inclu=* \ - | --x-incl=* | --x-inc=* | --x-in=* | --x-i=*) - x_includes=$ac_optarg ;; - - -x-libraries | --x-libraries | --x-librarie | --x-librari \ - | --x-librar | --x-libra | --x-libr | --x-lib | --x-li | --x-l) - ac_prev=x_libraries ;; - -x-libraries=* | --x-libraries=* | --x-librarie=* | --x-librari=* \ - | --x-librar=* | --x-libra=* | --x-libr=* | --x-lib=* | --x-li=* | --x-l=*) - x_libraries=$ac_optarg ;; - - -*) as_fn_error $? "unrecognized option: \`$ac_option' -Try \`$0 --help' for more information" - ;; - - *=*) - ac_envvar=`expr "x$ac_option" : 'x\([^=]*\)='` - # Reject names that are not valid shell variable names. - case $ac_envvar in #( - '' | [0-9]* | *[!_$as_cr_alnum]* ) - as_fn_error $? "invalid variable name: \`$ac_envvar'" ;; - esac - eval $ac_envvar=\$ac_optarg - export $ac_envvar ;; - - *) - # FIXME: should be removed in autoconf 3.0. - $as_echo "$as_me: WARNING: you should use --build, --host, --target" >&2 - expr "x$ac_option" : ".*[^-._$as_cr_alnum]" >/dev/null && - $as_echo "$as_me: WARNING: invalid host type: $ac_option" >&2 - : "${build_alias=$ac_option} ${host_alias=$ac_option} ${target_alias=$ac_option}" - ;; - - esac -done - -if test -n "$ac_prev"; then - ac_option=--`echo $ac_prev | sed 's/_/-/g'` - as_fn_error $? "missing argument to $ac_option" -fi - -if test -n "$ac_unrecognized_opts"; then - case $enable_option_checking in - no) ;; - fatal) as_fn_error $? "unrecognized options: $ac_unrecognized_opts" ;; - *) $as_echo "$as_me: WARNING: unrecognized options: $ac_unrecognized_opts" >&2 ;; - esac -fi - -# Check all directory arguments for consistency. -for ac_var in exec_prefix prefix bindir sbindir libexecdir datarootdir \ - datadir sysconfdir sharedstatedir localstatedir includedir \ - oldincludedir docdir infodir htmldir dvidir pdfdir psdir \ - libdir localedir mandir runstatedir -do - eval ac_val=\$$ac_var - # Remove trailing slashes. - case $ac_val in - */ ) - ac_val=`expr "X$ac_val" : 'X\(.*[^/]\)' \| "X$ac_val" : 'X\(.*\)'` - eval $ac_var=\$ac_val;; - esac - # Be sure to have absolute directory names. - case $ac_val in - [\\/$]* | ?:[\\/]* ) continue;; - NONE | '' ) case $ac_var in *prefix ) continue;; esac;; - esac - as_fn_error $? "expected an absolute directory name for --$ac_var: $ac_val" -done - -# There might be people who depend on the old broken behavior: `$host' -# used to hold the argument of --host etc. -# FIXME: To remove some day. -build=$build_alias -host=$host_alias -target=$target_alias - -# FIXME: To remove some day. -if test "x$host_alias" != x; then - if test "x$build_alias" = x; then - cross_compiling=maybe - elif test "x$build_alias" != "x$host_alias"; then - cross_compiling=yes - fi -fi - -ac_tool_prefix= -test -n "$host_alias" && ac_tool_prefix=$host_alias- - -test "$silent" = yes && exec 6>/dev/null - - -ac_pwd=`pwd` && test -n "$ac_pwd" && -ac_ls_di=`ls -di .` && -ac_pwd_ls_di=`cd "$ac_pwd" && ls -di .` || - as_fn_error $? "working directory cannot be determined" -test "X$ac_ls_di" = "X$ac_pwd_ls_di" || - as_fn_error $? "pwd does not report name of working directory" - - -# Find the source files, if location was not specified. -if test -z "$srcdir"; then - ac_srcdir_defaulted=yes - # Try the directory containing this script, then the parent directory. - ac_confdir=`$as_dirname -- "$as_myself" || -$as_expr X"$as_myself" : 'X\(.*[^/]\)//*[^/][^/]*/*$' \| \ - X"$as_myself" : 'X\(//\)[^/]' \| \ - X"$as_myself" : 'X\(//\)$' \| \ - X"$as_myself" : 'X\(/\)' \| . 2>/dev/null || -$as_echo X"$as_myself" | - sed '/^X\(.*[^/]\)\/\/*[^/][^/]*\/*$/{ - s//\1/ - q - } - /^X\(\/\/\)[^/].*/{ - s//\1/ - q - } - /^X\(\/\/\)$/{ - s//\1/ - q - } - /^X\(\/\).*/{ - s//\1/ - q - } - s/.*/./; q'` - srcdir=$ac_confdir - if test ! -r "$srcdir/$ac_unique_file"; then - srcdir=.. - fi -else - ac_srcdir_defaulted=no -fi -if test ! -r "$srcdir/$ac_unique_file"; then - test "$ac_srcdir_defaulted" = yes && srcdir="$ac_confdir or .." - as_fn_error $? "cannot find sources ($ac_unique_file) in $srcdir" -fi -ac_msg="sources are in $srcdir, but \`cd $srcdir' does not work" -ac_abs_confdir=`( - cd "$srcdir" && test -r "./$ac_unique_file" || as_fn_error $? "$ac_msg" - pwd)` -# When building in place, set srcdir=. -if test "$ac_abs_confdir" = "$ac_pwd"; then - srcdir=. -fi -# Remove unnecessary trailing slashes from srcdir. -# Double slashes in file names in object file debugging info -# mess up M-x gdb in Emacs. -case $srcdir in -*/) srcdir=`expr "X$srcdir" : 'X\(.*[^/]\)' \| "X$srcdir" : 'X\(.*\)'`;; -esac -for ac_var in $ac_precious_vars; do - eval ac_env_${ac_var}_set=\${${ac_var}+set} - eval ac_env_${ac_var}_value=\$${ac_var} - eval ac_cv_env_${ac_var}_set=\${${ac_var}+set} - eval ac_cv_env_${ac_var}_value=\$${ac_var} -done - -# -# Report the --help message. -# -if test "$ac_init_help" = "long"; then - # Omit some internal or obsolete options to make the list less imposing. - # This message is too long to be a string in the A/UX 3.1 sh. - cat <<_ACEOF -\`configure' configures Munipack 0.5.9 to adapt to many kinds of systems. - -Usage: $0 [OPTION]... [VAR=VALUE]... - -To assign environment variables (e.g., CC, CFLAGS...), specify them as -VAR=VALUE. See below for descriptions of some of the useful variables. - -Defaults for the options are specified in brackets. - -Configuration: - -h, --help display this help and exit - --help=short display options specific to this package - --help=recursive display the short help of all the included packages - -V, --version display version information and exit - -q, --quiet, --silent do not print \`checking ...' messages - --cache-file=FILE cache test results in FILE [disabled] - -C, --config-cache alias for \`--cache-file=config.cache' - -n, --no-create do not create output files - --srcdir=DIR find the sources in DIR [configure dir or \`..'] - -Installation directories: - --prefix=PREFIX install architecture-independent files in PREFIX - @<:@@S|@ac_default_prefix@:>@ - --exec-prefix=EPREFIX install architecture-dependent files in EPREFIX - @<:@PREFIX@:>@ - -By default, \`make install' will install all the files in -\`$ac_default_prefix/bin', \`$ac_default_prefix/lib' etc. You can specify -an installation prefix other than \`$ac_default_prefix' using \`--prefix', -for instance \`--prefix=\$HOME'. - -For better control, use the options below. - -Fine tuning of the installation directories: - --bindir=DIR user executables [EPREFIX/bin] - --sbindir=DIR system admin executables [EPREFIX/sbin] - --libexecdir=DIR program executables [EPREFIX/libexec] - --sysconfdir=DIR read-only single-machine data [PREFIX/etc] - --sharedstatedir=DIR modifiable architecture-independent data [PREFIX/com] - --localstatedir=DIR modifiable single-machine data [PREFIX/var] - --runstatedir=DIR modifiable per-process data [LOCALSTATEDIR/run] - --libdir=DIR object code libraries [EPREFIX/lib] - --includedir=DIR C header files [PREFIX/include] - --oldincludedir=DIR C header files for non-gcc [/usr/include] - --datarootdir=DIR read-only arch.-independent data root [PREFIX/share] - --datadir=DIR read-only architecture-independent data [DATAROOTDIR] - --infodir=DIR info documentation [DATAROOTDIR/info] - --localedir=DIR locale-dependent data [DATAROOTDIR/locale] - --mandir=DIR man documentation [DATAROOTDIR/man] - --docdir=DIR documentation root @<:@DATAROOTDIR/doc/munipack@:>@ - --htmldir=DIR html documentation [DOCDIR] - --dvidir=DIR dvi documentation [DOCDIR] - --pdfdir=DIR pdf documentation [DOCDIR] - --psdir=DIR ps documentation [DOCDIR] -_ACEOF - - cat <<\_ACEOF - -Program names: - --program-prefix=PREFIX prepend PREFIX to installed program names - --program-suffix=SUFFIX append SUFFIX to installed program names - --program-transform-name=PROGRAM run sed PROGRAM on installed program names - -System types: - --build=BUILD configure for building on BUILD [guessed] -_ACEOF -fi - -if test -n "$ac_init_help"; then - case $ac_init_help in - short | recursive ) echo "Configuration of Munipack 0.5.9:";; - esac - cat <<\_ACEOF - -Optional Features: - --disable-option-checking ignore unrecognized --enable/--with options - --disable-FEATURE do not include FEATURE (same as --enable-FEATURE=no) - --enable-FEATURE[=ARG] include FEATURE [ARG=yes] - --enable-silent-rules less verbose build output (undo: "make V=1") - --disable-silent-rules verbose build output (undo: "make V=0") - --enable-dependency-tracking - do not reject slow dependency extractors - --disable-dependency-tracking - speeds up one-time build - --disable-vo disable Virtual Observatory support - --disable-cli disable Command-line User Interface - --disable-gui disable Graphic User Interface - --enable-bundle install to self-contained directory (given - BUNDLEDIR) - -Optional Packages: - --with-PACKAGE[=ARG] use PACKAGE [ARG=yes] - --without-PACKAGE do not use PACKAGE (same as --with-PACKAGE=no) - --with-wxdir=PATH Use uninstalled version of wxWidgets in PATH - --with-wx-config=CONFIG wx-config script to use (optional) - --with-wx-prefix=PREFIX Prefix where wxWidgets is installed (optional) - --with-wx-exec-prefix=PREFIX - Exec prefix where wxWidgets is installed (optional) - -Some influential environment variables: - CC C compiler command - CFLAGS C compiler flags - LDFLAGS linker flags, e.g. -L if you have libraries in a - nonstandard directory - LIBS libraries to pass to the linker, e.g. -l - CPPFLAGS (Objective) C/C++ preprocessor flags, e.g. -I if - you have headers in a nonstandard directory - CXX C++ compiler command - CXXFLAGS C++ compiler flags - CPP C preprocessor - FC Fortran compiler command - FCFLAGS Fortran compiler flags - F77 Fortran 77 compiler command - FFLAGS Fortran 77 compiler flags - BUNDLEDIR prefix of self-contained directory @<:@/opt/munipack@:>@ - -Use these variables to override the choices made by `configure' or to help -it to find libraries and programs with nonstandard names/locations. - -Report bugs to >. -Munipack home page: . -_ACEOF -ac_status=$? -fi - -if test "$ac_init_help" = "recursive"; then - # If there are subdirs, report their specific --help. - for ac_dir in : $ac_subdirs_all; do test "x$ac_dir" = x: && continue - test -d "$ac_dir" || - { cd "$srcdir" && ac_pwd=`pwd` && srcdir=. && test -d "$ac_dir"; } || - continue - ac_builddir=. - -case "$ac_dir" in -.) ac_dir_suffix= ac_top_builddir_sub=. ac_top_build_prefix= ;; -*) - ac_dir_suffix=/`$as_echo "$ac_dir" | sed 's|^\.[\\/]||'` - # A ".." for each directory in $ac_dir_suffix. - ac_top_builddir_sub=`$as_echo "$ac_dir_suffix" | sed 's|/[^\\/]*|/..|g;s|/||'` - case $ac_top_builddir_sub in - "") ac_top_builddir_sub=. ac_top_build_prefix= ;; - *) ac_top_build_prefix=$ac_top_builddir_sub/ ;; - esac ;; -esac -ac_abs_top_builddir=$ac_pwd -ac_abs_builddir=$ac_pwd$ac_dir_suffix -# for backward compatibility: -ac_top_builddir=$ac_top_build_prefix - -case $srcdir in - .) # We are building in place. - ac_srcdir=. - ac_top_srcdir=$ac_top_builddir_sub - ac_abs_top_srcdir=$ac_pwd ;; - [\\/]* | ?:[\\/]* ) # Absolute name. - ac_srcdir=$srcdir$ac_dir_suffix; - ac_top_srcdir=$srcdir - ac_abs_top_srcdir=$srcdir ;; - *) # Relative name. - ac_srcdir=$ac_top_build_prefix$srcdir$ac_dir_suffix - ac_top_srcdir=$ac_top_build_prefix$srcdir - ac_abs_top_srcdir=$ac_pwd/$srcdir ;; -esac -ac_abs_srcdir=$ac_abs_top_srcdir$ac_dir_suffix - - cd "$ac_dir" || { ac_status=$?; continue; } - # Check for guested configure. - if test -f "$ac_srcdir/configure.gnu"; then - echo && - $SHELL "$ac_srcdir/configure.gnu" --help=recursive - elif test -f "$ac_srcdir/configure"; then - echo && - $SHELL "$ac_srcdir/configure" --help=recursive - else - $as_echo "$as_me: WARNING: no configuration information is in $ac_dir" >&2 - fi || ac_status=$? - cd "$ac_pwd" || { ac_status=$?; break; } - done -fi - -test -n "$ac_init_help" && exit $ac_status -if $ac_init_version; then - cat <<\_ACEOF -Munipack configure 0.5.9 -generated by GNU Autoconf 2.69 - -Copyright (C) 2012 Free Software Foundation, Inc. -This configure script is free software; the Free Software Foundation -gives unlimited permission to copy, distribute and modify it. -_ACEOF - exit -fi - -## ------------------------ ## -## Autoconf initialization. ## -## ------------------------ ## - -@%:@ ac_fn_c_try_compile LINENO -@%:@ -------------------------- -@%:@ Try to compile conftest.@S|@ac_ext, and return whether this succeeded. -ac_fn_c_try_compile () -{ - as_lineno=${as_lineno-"$1"} as_lineno_stack=as_lineno_stack=$as_lineno_stack - rm -f conftest.$ac_objext - if { { ac_try="$ac_compile" -case "(($ac_try" in - *\"* | *\`* | *\\*) ac_try_echo=\$ac_try;; - *) ac_try_echo=$ac_try;; -esac -eval ac_try_echo="\"\$as_me:${as_lineno-$LINENO}: $ac_try_echo\"" -$as_echo "$ac_try_echo"; } >&5 - (eval "$ac_compile") 2>conftest.err - ac_status=$? - if test -s conftest.err; then - grep -v '^ *+' conftest.err >conftest.er1 - cat conftest.er1 >&5 - mv -f conftest.er1 conftest.err - fi - $as_echo "$as_me:${as_lineno-$LINENO}: \$? = $ac_status" >&5 - test $ac_status = 0; } && { - test -z "$ac_c_werror_flag" || - test ! -s conftest.err - } && test -s conftest.$ac_objext; then : - ac_retval=0 -else - $as_echo "$as_me: failed program was:" >&5 -sed 's/^/| /' conftest.$ac_ext >&5 - - ac_retval=1 -fi - eval $as_lineno_stack; ${as_lineno_stack:+:} unset as_lineno - as_fn_set_status $ac_retval - -} @%:@ ac_fn_c_try_compile - -@%:@ ac_fn_cxx_try_compile LINENO -@%:@ ---------------------------- -@%:@ Try to compile conftest.@S|@ac_ext, and return whether this succeeded. -ac_fn_cxx_try_compile () -{ - as_lineno=${as_lineno-"$1"} as_lineno_stack=as_lineno_stack=$as_lineno_stack - rm -f conftest.$ac_objext - if { { ac_try="$ac_compile" -case "(($ac_try" in - *\"* | *\`* | *\\*) ac_try_echo=\$ac_try;; - *) ac_try_echo=$ac_try;; -esac -eval ac_try_echo="\"\$as_me:${as_lineno-$LINENO}: $ac_try_echo\"" -$as_echo "$ac_try_echo"; } >&5 - (eval "$ac_compile") 2>conftest.err - ac_status=$? - if test -s conftest.err; then - grep -v '^ *+' conftest.err >conftest.er1 - cat conftest.er1 >&5 - mv -f conftest.er1 conftest.err - fi - $as_echo "$as_me:${as_lineno-$LINENO}: \$? = $ac_status" >&5 - test $ac_status = 0; } && { - test -z "$ac_cxx_werror_flag" || - test ! -s conftest.err - } && test -s conftest.$ac_objext; then : - ac_retval=0 -else - $as_echo "$as_me: failed program was:" >&5 -sed 's/^/| /' conftest.$ac_ext >&5 - - ac_retval=1 -fi - eval $as_lineno_stack; ${as_lineno_stack:+:} unset as_lineno - as_fn_set_status $ac_retval - -} @%:@ ac_fn_cxx_try_compile - -@%:@ ac_fn_c_try_cpp LINENO -@%:@ ---------------------- -@%:@ Try to preprocess conftest.@S|@ac_ext, and return whether this succeeded. -ac_fn_c_try_cpp () -{ - as_lineno=${as_lineno-"$1"} as_lineno_stack=as_lineno_stack=$as_lineno_stack - if { { ac_try="$ac_cpp conftest.$ac_ext" -case "(($ac_try" in - *\"* | *\`* | *\\*) ac_try_echo=\$ac_try;; - *) ac_try_echo=$ac_try;; -esac -eval ac_try_echo="\"\$as_me:${as_lineno-$LINENO}: $ac_try_echo\"" -$as_echo "$ac_try_echo"; } >&5 - (eval "$ac_cpp conftest.$ac_ext") 2>conftest.err - ac_status=$? - if test -s conftest.err; then - grep -v '^ *+' conftest.err >conftest.er1 - cat conftest.er1 >&5 - mv -f conftest.er1 conftest.err - fi - $as_echo "$as_me:${as_lineno-$LINENO}: \$? = $ac_status" >&5 - test $ac_status = 0; } > conftest.i && { - test -z "$ac_c_preproc_warn_flag$ac_c_werror_flag" || - test ! -s conftest.err - }; then : - ac_retval=0 -else - $as_echo "$as_me: failed program was:" >&5 -sed 's/^/| /' conftest.$ac_ext >&5 - - ac_retval=1 -fi - eval $as_lineno_stack; ${as_lineno_stack:+:} unset as_lineno - as_fn_set_status $ac_retval - -} @%:@ ac_fn_c_try_cpp - -@%:@ ac_fn_fc_try_compile LINENO -@%:@ --------------------------- -@%:@ Try to compile conftest.@S|@ac_ext, and return whether this succeeded. -ac_fn_fc_try_compile () -{ - as_lineno=${as_lineno-"$1"} as_lineno_stack=as_lineno_stack=$as_lineno_stack - rm -f conftest.$ac_objext - if { { ac_try="$ac_compile" -case "(($ac_try" in - *\"* | *\`* | *\\*) ac_try_echo=\$ac_try;; - *) ac_try_echo=$ac_try;; -esac -eval ac_try_echo="\"\$as_me:${as_lineno-$LINENO}: $ac_try_echo\"" -$as_echo "$ac_try_echo"; } >&5 - (eval "$ac_compile") 2>conftest.err - ac_status=$? - if test -s conftest.err; then - grep -v '^ *+' conftest.err >conftest.er1 - cat conftest.er1 >&5 - mv -f conftest.er1 conftest.err - fi - $as_echo "$as_me:${as_lineno-$LINENO}: \$? = $ac_status" >&5 - test $ac_status = 0; } && { - test -z "$ac_fc_werror_flag" || - test ! -s conftest.err - } && test -s conftest.$ac_objext; then : - ac_retval=0 -else - $as_echo "$as_me: failed program was:" >&5 -sed 's/^/| /' conftest.$ac_ext >&5 - - ac_retval=1 -fi - eval $as_lineno_stack; ${as_lineno_stack:+:} unset as_lineno - as_fn_set_status $ac_retval - -} @%:@ ac_fn_fc_try_compile - -@%:@ ac_fn_c_try_run LINENO -@%:@ ---------------------- -@%:@ Try to link conftest.@S|@ac_ext, and return whether this succeeded. Assumes -@%:@ that executables *can* be run. -ac_fn_c_try_run () -{ - as_lineno=${as_lineno-"$1"} as_lineno_stack=as_lineno_stack=$as_lineno_stack - if { { ac_try="$ac_link" -case "(($ac_try" in - *\"* | *\`* | *\\*) ac_try_echo=\$ac_try;; - *) ac_try_echo=$ac_try;; -esac -eval ac_try_echo="\"\$as_me:${as_lineno-$LINENO}: $ac_try_echo\"" -$as_echo "$ac_try_echo"; } >&5 - (eval "$ac_link") 2>&5 - ac_status=$? - $as_echo "$as_me:${as_lineno-$LINENO}: \$? = $ac_status" >&5 - test $ac_status = 0; } && { ac_try='./conftest$ac_exeext' - { { case "(($ac_try" in - *\"* | *\`* | *\\*) ac_try_echo=\$ac_try;; - *) ac_try_echo=$ac_try;; -esac -eval ac_try_echo="\"\$as_me:${as_lineno-$LINENO}: $ac_try_echo\"" -$as_echo "$ac_try_echo"; } >&5 - (eval "$ac_try") 2>&5 - ac_status=$? - $as_echo "$as_me:${as_lineno-$LINENO}: \$? = $ac_status" >&5 - test $ac_status = 0; }; }; then : - ac_retval=0 -else - $as_echo "$as_me: program exited with status $ac_status" >&5 - $as_echo "$as_me: failed program was:" >&5 -sed 's/^/| /' conftest.$ac_ext >&5 - - ac_retval=$ac_status -fi - rm -rf conftest.dSYM conftest_ipa8_conftest.oo - eval $as_lineno_stack; ${as_lineno_stack:+:} unset as_lineno - as_fn_set_status $ac_retval - -} @%:@ ac_fn_c_try_run - -@%:@ ac_fn_c_check_type LINENO TYPE VAR INCLUDES -@%:@ ------------------------------------------- -@%:@ Tests whether TYPE exists after having included INCLUDES, setting cache -@%:@ variable VAR accordingly. -ac_fn_c_check_type () -{ - as_lineno=${as_lineno-"$1"} as_lineno_stack=as_lineno_stack=$as_lineno_stack - { $as_echo "$as_me:${as_lineno-$LINENO}: checking for $2" >&5 -$as_echo_n "checking for $2... " >&6; } -if eval \${$3+:} false; then : - $as_echo_n "(cached) " >&6 -else - eval "$3=no" - cat confdefs.h - <<_ACEOF >conftest.$ac_ext -/* end confdefs.h. */ -$4 -int -main () -{ -if (sizeof ($2)) - return 0; - ; - return 0; -} -_ACEOF -if ac_fn_c_try_compile "$LINENO"; then : - cat confdefs.h - <<_ACEOF >conftest.$ac_ext -/* end confdefs.h. */ -$4 -int -main () -{ -if (sizeof (($2))) - return 0; - ; - return 0; -} -_ACEOF -if ac_fn_c_try_compile "$LINENO"; then : - -else - eval "$3=yes" -fi -rm -f core conftest.err conftest.$ac_objext conftest.$ac_ext -fi -rm -f core conftest.err conftest.$ac_objext conftest.$ac_ext -fi -eval ac_res=\$$3 - { $as_echo "$as_me:${as_lineno-$LINENO}: result: $ac_res" >&5 -$as_echo "$ac_res" >&6; } - eval $as_lineno_stack; ${as_lineno_stack:+:} unset as_lineno - -} @%:@ ac_fn_c_check_type - -@%:@ ac_fn_c_check_header_compile LINENO HEADER VAR INCLUDES -@%:@ ------------------------------------------------------- -@%:@ Tests whether HEADER exists and can be compiled using the include files in -@%:@ INCLUDES, setting the cache variable VAR accordingly. -ac_fn_c_check_header_compile () -{ - as_lineno=${as_lineno-"$1"} as_lineno_stack=as_lineno_stack=$as_lineno_stack - { $as_echo "$as_me:${as_lineno-$LINENO}: checking for $2" >&5 -$as_echo_n "checking for $2... " >&6; } -if eval \${$3+:} false; then : - $as_echo_n "(cached) " >&6 -else - cat confdefs.h - <<_ACEOF >conftest.$ac_ext -/* end confdefs.h. */ -$4 -@%:@include <$2> -_ACEOF -if ac_fn_c_try_compile "$LINENO"; then : - eval "$3=yes" -else - eval "$3=no" -fi -rm -f core conftest.err conftest.$ac_objext conftest.$ac_ext -fi -eval ac_res=\$$3 - { $as_echo "$as_me:${as_lineno-$LINENO}: result: $ac_res" >&5 -$as_echo "$ac_res" >&6; } - eval $as_lineno_stack; ${as_lineno_stack:+:} unset as_lineno - -} @%:@ ac_fn_c_check_header_compile - -@%:@ ac_fn_c_check_header_mongrel LINENO HEADER VAR INCLUDES -@%:@ ------------------------------------------------------- -@%:@ Tests whether HEADER exists, giving a warning if it cannot be compiled using -@%:@ the include files in INCLUDES and setting the cache variable VAR -@%:@ accordingly. -ac_fn_c_check_header_mongrel () -{ - as_lineno=${as_lineno-"$1"} as_lineno_stack=as_lineno_stack=$as_lineno_stack - if eval \${$3+:} false; then : - { $as_echo "$as_me:${as_lineno-$LINENO}: checking for $2" >&5 -$as_echo_n "checking for $2... " >&6; } -if eval \${$3+:} false; then : - $as_echo_n "(cached) " >&6 -fi -eval ac_res=\$$3 - { $as_echo "$as_me:${as_lineno-$LINENO}: result: $ac_res" >&5 -$as_echo "$ac_res" >&6; } -else - # Is the header compilable? -{ $as_echo "$as_me:${as_lineno-$LINENO}: checking $2 usability" >&5 -$as_echo_n "checking $2 usability... " >&6; } -cat confdefs.h - <<_ACEOF >conftest.$ac_ext -/* end confdefs.h. */ -$4 -@%:@include <$2> -_ACEOF -if ac_fn_c_try_compile "$LINENO"; then : - ac_header_compiler=yes -else - ac_header_compiler=no -fi -rm -f core conftest.err conftest.$ac_objext conftest.$ac_ext -{ $as_echo "$as_me:${as_lineno-$LINENO}: result: $ac_header_compiler" >&5 -$as_echo "$ac_header_compiler" >&6; } - -# Is the header present? -{ $as_echo "$as_me:${as_lineno-$LINENO}: checking $2 presence" >&5 -$as_echo_n "checking $2 presence... " >&6; } -cat confdefs.h - <<_ACEOF >conftest.$ac_ext -/* end confdefs.h. */ -@%:@include <$2> -_ACEOF -if ac_fn_c_try_cpp "$LINENO"; then : - ac_header_preproc=yes -else - ac_header_preproc=no -fi -rm -f conftest.err conftest.i conftest.$ac_ext -{ $as_echo "$as_me:${as_lineno-$LINENO}: result: $ac_header_preproc" >&5 -$as_echo "$ac_header_preproc" >&6; } - -# So? What about this header? -case $ac_header_compiler:$ac_header_preproc:$ac_c_preproc_warn_flag in #(( - yes:no: ) - { $as_echo "$as_me:${as_lineno-$LINENO}: WARNING: $2: accepted by the compiler, rejected by the preprocessor!" >&5 -$as_echo "$as_me: WARNING: $2: accepted by the compiler, rejected by the preprocessor!" >&2;} - { $as_echo "$as_me:${as_lineno-$LINENO}: WARNING: $2: proceeding with the compiler's result" >&5 -$as_echo "$as_me: WARNING: $2: proceeding with the compiler's result" >&2;} - ;; - no:yes:* ) - { $as_echo "$as_me:${as_lineno-$LINENO}: WARNING: $2: present but cannot be compiled" >&5 -$as_echo "$as_me: WARNING: $2: present but cannot be compiled" >&2;} - { $as_echo "$as_me:${as_lineno-$LINENO}: WARNING: $2: check for missing prerequisite headers?" >&5 -$as_echo "$as_me: WARNING: $2: check for missing prerequisite headers?" >&2;} - { $as_echo "$as_me:${as_lineno-$LINENO}: WARNING: $2: see the Autoconf documentation" >&5 -$as_echo "$as_me: WARNING: $2: see the Autoconf documentation" >&2;} - { $as_echo "$as_me:${as_lineno-$LINENO}: WARNING: $2: section \"Present But Cannot Be Compiled\"" >&5 -$as_echo "$as_me: WARNING: $2: section \"Present But Cannot Be Compiled\"" >&2;} - { $as_echo "$as_me:${as_lineno-$LINENO}: WARNING: $2: proceeding with the compiler's result" >&5 -$as_echo "$as_me: WARNING: $2: proceeding with the compiler's result" >&2;} -( $as_echo "## -------------------------------------------------- ## -## Report this to Filip Hroch ## -## -------------------------------------------------- ##" - ) | sed "s/^/$as_me: WARNING: /" >&2 - ;; -esac - { $as_echo "$as_me:${as_lineno-$LINENO}: checking for $2" >&5 -$as_echo_n "checking for $2... " >&6; } -if eval \${$3+:} false; then : - $as_echo_n "(cached) " >&6 -else - eval "$3=\$ac_header_compiler" -fi -eval ac_res=\$$3 - { $as_echo "$as_me:${as_lineno-$LINENO}: result: $ac_res" >&5 -$as_echo "$ac_res" >&6; } -fi - eval $as_lineno_stack; ${as_lineno_stack:+:} unset as_lineno - -} @%:@ ac_fn_c_check_header_mongrel - -@%:@ ac_fn_c_try_link LINENO -@%:@ ----------------------- -@%:@ Try to link conftest.@S|@ac_ext, and return whether this succeeded. -ac_fn_c_try_link () -{ - as_lineno=${as_lineno-"$1"} as_lineno_stack=as_lineno_stack=$as_lineno_stack - rm -f conftest.$ac_objext conftest$ac_exeext - if { { ac_try="$ac_link" -case "(($ac_try" in - *\"* | *\`* | *\\*) ac_try_echo=\$ac_try;; - *) ac_try_echo=$ac_try;; -esac -eval ac_try_echo="\"\$as_me:${as_lineno-$LINENO}: $ac_try_echo\"" -$as_echo "$ac_try_echo"; } >&5 - (eval "$ac_link") 2>conftest.err - ac_status=$? - if test -s conftest.err; then - grep -v '^ *+' conftest.err >conftest.er1 - cat conftest.er1 >&5 - mv -f conftest.er1 conftest.err - fi - $as_echo "$as_me:${as_lineno-$LINENO}: \$? = $ac_status" >&5 - test $ac_status = 0; } && { - test -z "$ac_c_werror_flag" || - test ! -s conftest.err - } && test -s conftest$ac_exeext && { - test "$cross_compiling" = yes || - test -x conftest$ac_exeext - }; then : - ac_retval=0 -else - $as_echo "$as_me: failed program was:" >&5 -sed 's/^/| /' conftest.$ac_ext >&5 - - ac_retval=1 -fi - # Delete the IPA/IPO (Inter Procedural Analysis/Optimization) information - # created by the PGI compiler (conftest_ipa8_conftest.oo), as it would - # interfere with the next link command; also delete a directory that is - # left behind by Apple's compiler. We do this before executing the actions. - rm -rf conftest.dSYM conftest_ipa8_conftest.oo - eval $as_lineno_stack; ${as_lineno_stack:+:} unset as_lineno - as_fn_set_status $ac_retval - -} @%:@ ac_fn_c_try_link - -@%:@ ac_fn_f77_try_compile LINENO -@%:@ ---------------------------- -@%:@ Try to compile conftest.@S|@ac_ext, and return whether this succeeded. -ac_fn_f77_try_compile () -{ - as_lineno=${as_lineno-"$1"} as_lineno_stack=as_lineno_stack=$as_lineno_stack - rm -f conftest.$ac_objext - if { { ac_try="$ac_compile" -case "(($ac_try" in - *\"* | *\`* | *\\*) ac_try_echo=\$ac_try;; - *) ac_try_echo=$ac_try;; -esac -eval ac_try_echo="\"\$as_me:${as_lineno-$LINENO}: $ac_try_echo\"" -$as_echo "$ac_try_echo"; } >&5 - (eval "$ac_compile") 2>conftest.err - ac_status=$? - if test -s conftest.err; then - grep -v '^ *+' conftest.err >conftest.er1 - cat conftest.er1 >&5 - mv -f conftest.er1 conftest.err - fi - $as_echo "$as_me:${as_lineno-$LINENO}: \$? = $ac_status" >&5 - test $ac_status = 0; } && { - test -z "$ac_f77_werror_flag" || - test ! -s conftest.err - } && test -s conftest.$ac_objext; then : - ac_retval=0 -else - $as_echo "$as_me: failed program was:" >&5 -sed 's/^/| /' conftest.$ac_ext >&5 - - ac_retval=1 -fi - eval $as_lineno_stack; ${as_lineno_stack:+:} unset as_lineno - as_fn_set_status $ac_retval - -} @%:@ ac_fn_f77_try_compile -cat >config.log <<_ACEOF -This file contains any messages produced by compilers while -running configure, to aid debugging if configure makes a mistake. - -It was created by Munipack $as_me 0.5.9, which was -generated by GNU Autoconf 2.69. Invocation command line was - - $ $0 $@ - -_ACEOF -exec 5>>config.log -{ -cat <<_ASUNAME -## --------- ## -## Platform. ## -## --------- ## - -hostname = `(hostname || uname -n) 2>/dev/null | sed 1q` -uname -m = `(uname -m) 2>/dev/null || echo unknown` -uname -r = `(uname -r) 2>/dev/null || echo unknown` -uname -s = `(uname -s) 2>/dev/null || echo unknown` -uname -v = `(uname -v) 2>/dev/null || echo unknown` - -/usr/bin/uname -p = `(/usr/bin/uname -p) 2>/dev/null || echo unknown` -/bin/uname -X = `(/bin/uname -X) 2>/dev/null || echo unknown` - -/bin/arch = `(/bin/arch) 2>/dev/null || echo unknown` -/usr/bin/arch -k = `(/usr/bin/arch -k) 2>/dev/null || echo unknown` -/usr/convex/getsysinfo = `(/usr/convex/getsysinfo) 2>/dev/null || echo unknown` -/usr/bin/hostinfo = `(/usr/bin/hostinfo) 2>/dev/null || echo unknown` -/bin/machine = `(/bin/machine) 2>/dev/null || echo unknown` -/usr/bin/oslevel = `(/usr/bin/oslevel) 2>/dev/null || echo unknown` -/bin/universe = `(/bin/universe) 2>/dev/null || echo unknown` - -_ASUNAME - -as_save_IFS=$IFS; IFS=$PATH_SEPARATOR -for as_dir in $PATH -do - IFS=$as_save_IFS - test -z "$as_dir" && as_dir=. - $as_echo "PATH: $as_dir" - done -IFS=$as_save_IFS - -} >&5 - -cat >&5 <<_ACEOF - - -## ----------- ## -## Core tests. ## -## ----------- ## - -_ACEOF - - -# Keep a trace of the command line. -# Strip out --no-create and --no-recursion so they do not pile up. -# Strip out --silent because we don't want to record it for future runs. -# Also quote any args containing shell meta-characters. -# Make two passes to allow for proper duplicate-argument suppression. -ac_configure_args= -ac_configure_args0= -ac_configure_args1= -ac_must_keep_next=false -for ac_pass in 1 2 -do - for ac_arg - do - case $ac_arg in - -no-create | --no-c* | -n | -no-recursion | --no-r*) continue ;; - -q | -quiet | --quiet | --quie | --qui | --qu | --q \ - | -silent | --silent | --silen | --sile | --sil) - continue ;; - *\'*) - ac_arg=`$as_echo "$ac_arg" | sed "s/'/'\\\\\\\\''/g"` ;; - esac - case $ac_pass in - 1) as_fn_append ac_configure_args0 " '$ac_arg'" ;; - 2) - as_fn_append ac_configure_args1 " '$ac_arg'" - if test $ac_must_keep_next = true; then - ac_must_keep_next=false # Got value, back to normal. - else - case $ac_arg in - *=* | --config-cache | -C | -disable-* | --disable-* \ - | -enable-* | --enable-* | -gas | --g* | -nfp | --nf* \ - | -q | -quiet | --q* | -silent | --sil* | -v | -verb* \ - | -with-* | --with-* | -without-* | --without-* | --x) - case "$ac_configure_args0 " in - "$ac_configure_args1"*" '$ac_arg' "* ) continue ;; - esac - ;; - -* ) ac_must_keep_next=true ;; - esac - fi - as_fn_append ac_configure_args " '$ac_arg'" - ;; - esac - done -done -{ ac_configure_args0=; unset ac_configure_args0;} -{ ac_configure_args1=; unset ac_configure_args1;} - -# When interrupted or exit'd, cleanup temporary files, and complete -# config.log. We remove comments because anyway the quotes in there -# would cause problems or look ugly. -# WARNING: Use '\'' to represent an apostrophe within the trap. -# WARNING: Do not start the trap code with a newline, due to a FreeBSD 4.0 bug. -trap 'exit_status=$? - # Save into config.log some information that might help in debugging. - { - echo - - $as_echo "## ---------------- ## -## Cache variables. ## -## ---------------- ##" - echo - # The following way of writing the cache mishandles newlines in values, -( - for ac_var in `(set) 2>&1 | sed -n '\''s/^\([a-zA-Z_][a-zA-Z0-9_]*\)=.*/\1/p'\''`; do - eval ac_val=\$$ac_var - case $ac_val in #( - *${as_nl}*) - case $ac_var in #( - *_cv_*) { $as_echo "$as_me:${as_lineno-$LINENO}: WARNING: cache variable $ac_var contains a newline" >&5 -$as_echo "$as_me: WARNING: cache variable $ac_var contains a newline" >&2;} ;; - esac - case $ac_var in #( - _ | IFS | as_nl) ;; #( - BASH_ARGV | BASH_SOURCE) eval $ac_var= ;; #( - *) { eval $ac_var=; unset $ac_var;} ;; - esac ;; - esac - done - (set) 2>&1 | - case $as_nl`(ac_space='\'' '\''; set) 2>&1` in #( - *${as_nl}ac_space=\ *) - sed -n \ - "s/'\''/'\''\\\\'\'''\''/g; - s/^\\([_$as_cr_alnum]*_cv_[_$as_cr_alnum]*\\)=\\(.*\\)/\\1='\''\\2'\''/p" - ;; #( - *) - sed -n "/^[_$as_cr_alnum]*_cv_[_$as_cr_alnum]*=/p" - ;; - esac | - sort -) - echo - - $as_echo "## ----------------- ## -## Output variables. ## -## ----------------- ##" - echo - for ac_var in $ac_subst_vars - do - eval ac_val=\$$ac_var - case $ac_val in - *\'\''*) ac_val=`$as_echo "$ac_val" | sed "s/'\''/'\''\\\\\\\\'\'''\''/g"`;; - esac - $as_echo "$ac_var='\''$ac_val'\''" - done | sort - echo - - if test -n "$ac_subst_files"; then - $as_echo "## ------------------- ## -## File substitutions. ## -## ------------------- ##" - echo - for ac_var in $ac_subst_files - do - eval ac_val=\$$ac_var - case $ac_val in - *\'\''*) ac_val=`$as_echo "$ac_val" | sed "s/'\''/'\''\\\\\\\\'\'''\''/g"`;; - esac - $as_echo "$ac_var='\''$ac_val'\''" - done | sort - echo - fi - - if test -s confdefs.h; then - $as_echo "## ----------- ## -## confdefs.h. ## -## ----------- ##" - echo - cat confdefs.h - echo - fi - test "$ac_signal" != 0 && - $as_echo "$as_me: caught signal $ac_signal" - $as_echo "$as_me: exit $exit_status" - } >&5 - rm -f core *.core core.conftest.* && - rm -f -r conftest* confdefs* conf$$* $ac_clean_files && - exit $exit_status -' 0 -for ac_signal in 1 2 13 15; do - trap 'ac_signal='$ac_signal'; as_fn_exit 1' $ac_signal -done -ac_signal=0 - -# confdefs.h avoids OS command line length limits that DEFS can exceed. -rm -f -r conftest* confdefs.h - -$as_echo "/* confdefs.h */" > confdefs.h - -# Predefined preprocessor variables. - -cat >>confdefs.h <<_ACEOF -@%:@define PACKAGE_NAME "$PACKAGE_NAME" -_ACEOF - -cat >>confdefs.h <<_ACEOF -@%:@define PACKAGE_TARNAME "$PACKAGE_TARNAME" -_ACEOF - -cat >>confdefs.h <<_ACEOF -@%:@define PACKAGE_VERSION "$PACKAGE_VERSION" -_ACEOF - -cat >>confdefs.h <<_ACEOF -@%:@define PACKAGE_STRING "$PACKAGE_STRING" -_ACEOF - -cat >>confdefs.h <<_ACEOF -@%:@define PACKAGE_BUGREPORT "$PACKAGE_BUGREPORT" -_ACEOF - -cat >>confdefs.h <<_ACEOF -@%:@define PACKAGE_URL "$PACKAGE_URL" -_ACEOF - - -# Let the site file select an alternate cache file if it wants to. -# Prefer an explicitly selected file to automatically selected ones. -ac_site_file1=NONE -ac_site_file2=NONE -if test -n "$CONFIG_SITE"; then - # We do not want a PATH search for config.site. - case $CONFIG_SITE in @%:@(( - -*) ac_site_file1=./$CONFIG_SITE;; - */*) ac_site_file1=$CONFIG_SITE;; - *) ac_site_file1=./$CONFIG_SITE;; - esac -elif test "x$prefix" != xNONE; then - ac_site_file1=$prefix/share/config.site - ac_site_file2=$prefix/etc/config.site -else - ac_site_file1=$ac_default_prefix/share/config.site - ac_site_file2=$ac_default_prefix/etc/config.site -fi -for ac_site_file in "$ac_site_file1" "$ac_site_file2" -do - test "x$ac_site_file" = xNONE && continue - if test /dev/null != "$ac_site_file" && test -r "$ac_site_file"; then - { $as_echo "$as_me:${as_lineno-$LINENO}: loading site script $ac_site_file" >&5 -$as_echo "$as_me: loading site script $ac_site_file" >&6;} - sed 's/^/| /' "$ac_site_file" >&5 - . "$ac_site_file" \ - || { { $as_echo "$as_me:${as_lineno-$LINENO}: error: in \`$ac_pwd':" >&5 -$as_echo "$as_me: error: in \`$ac_pwd':" >&2;} -as_fn_error $? "failed to load site script $ac_site_file -See \`config.log' for more details" "$LINENO" 5; } - fi -done - -if test -r "$cache_file"; then - # Some versions of bash will fail to source /dev/null (special files - # actually), so we avoid doing that. DJGPP emulates it as a regular file. - if test /dev/null != "$cache_file" && test -f "$cache_file"; then - { $as_echo "$as_me:${as_lineno-$LINENO}: loading cache $cache_file" >&5 -$as_echo "$as_me: loading cache $cache_file" >&6;} - case $cache_file in - [\\/]* | ?:[\\/]* ) . "$cache_file";; - *) . "./$cache_file";; - esac - fi -else - { $as_echo "$as_me:${as_lineno-$LINENO}: creating cache $cache_file" >&5 -$as_echo "$as_me: creating cache $cache_file" >&6;} - >$cache_file -fi - -# Check that the precious variables saved in the cache have kept the same -# value. -ac_cache_corrupted=false -for ac_var in $ac_precious_vars; do - eval ac_old_set=\$ac_cv_env_${ac_var}_set - eval ac_new_set=\$ac_env_${ac_var}_set - eval ac_old_val=\$ac_cv_env_${ac_var}_value - eval ac_new_val=\$ac_env_${ac_var}_value - case $ac_old_set,$ac_new_set in - set,) - { $as_echo "$as_me:${as_lineno-$LINENO}: error: \`$ac_var' was set to \`$ac_old_val' in the previous run" >&5 -$as_echo "$as_me: error: \`$ac_var' was set to \`$ac_old_val' in the previous run" >&2;} - ac_cache_corrupted=: ;; - ,set) - { $as_echo "$as_me:${as_lineno-$LINENO}: error: \`$ac_var' was not set in the previous run" >&5 -$as_echo "$as_me: error: \`$ac_var' was not set in the previous run" >&2;} - ac_cache_corrupted=: ;; - ,);; - *) - if test "x$ac_old_val" != "x$ac_new_val"; then - # differences in whitespace do not lead to failure. - ac_old_val_w=`echo x $ac_old_val` - ac_new_val_w=`echo x $ac_new_val` - if test "$ac_old_val_w" != "$ac_new_val_w"; then - { $as_echo "$as_me:${as_lineno-$LINENO}: error: \`$ac_var' has changed since the previous run:" >&5 -$as_echo "$as_me: error: \`$ac_var' has changed since the previous run:" >&2;} - ac_cache_corrupted=: - else - { $as_echo "$as_me:${as_lineno-$LINENO}: warning: ignoring whitespace changes in \`$ac_var' since the previous run:" >&5 -$as_echo "$as_me: warning: ignoring whitespace changes in \`$ac_var' since the previous run:" >&2;} - eval $ac_var=\$ac_old_val - fi - { $as_echo "$as_me:${as_lineno-$LINENO}: former value: \`$ac_old_val'" >&5 -$as_echo "$as_me: former value: \`$ac_old_val'" >&2;} - { $as_echo "$as_me:${as_lineno-$LINENO}: current value: \`$ac_new_val'" >&5 -$as_echo "$as_me: current value: \`$ac_new_val'" >&2;} - fi;; - esac - # Pass precious variables to config.status. - if test "$ac_new_set" = set; then - case $ac_new_val in - *\'*) ac_arg=$ac_var=`$as_echo "$ac_new_val" | sed "s/'/'\\\\\\\\''/g"` ;; - *) ac_arg=$ac_var=$ac_new_val ;; - esac - case " $ac_configure_args " in - *" '$ac_arg' "*) ;; # Avoid dups. Use of quotes ensures accuracy. - *) as_fn_append ac_configure_args " '$ac_arg'" ;; - esac - fi -done -if $ac_cache_corrupted; then - { $as_echo "$as_me:${as_lineno-$LINENO}: error: in \`$ac_pwd':" >&5 -$as_echo "$as_me: error: in \`$ac_pwd':" >&2;} - { $as_echo "$as_me:${as_lineno-$LINENO}: error: changes in the environment can compromise the build" >&5 -$as_echo "$as_me: error: changes in the environment can compromise the build" >&2;} - as_fn_error $? "run \`make distclean' and/or \`rm $cache_file' and start over" "$LINENO" 5 -fi -## -------------------- ## -## Main body of script. ## -## -------------------- ## - -ac_ext=c -ac_cpp='$CPP $CPPFLAGS' -ac_compile='$CC -c $CFLAGS $CPPFLAGS conftest.$ac_ext >&5' -ac_link='$CC -o conftest$ac_exeext $CFLAGS $CPPFLAGS $LDFLAGS conftest.$ac_ext $LIBS >&5' -ac_compiler_gnu=$ac_cv_c_compiler_gnu - - - -develop=no - -if test "x$develop" = "xyes"; then - -$as_echo "@%:@define DEVELBUILD 1" >>confdefs.h - - -cat >>confdefs.h <<_ACEOF -@%:@define DATEBUILD `date +'"%F %T %Z"'` -_ACEOF - -fi - - -ac_aux_dir= -for ac_dir in "$srcdir" "$srcdir/.." "$srcdir/../.."; do - if test -f "$ac_dir/install-sh"; then - ac_aux_dir=$ac_dir - ac_install_sh="$ac_aux_dir/install-sh -c" - break - elif test -f "$ac_dir/install.sh"; then - ac_aux_dir=$ac_dir - ac_install_sh="$ac_aux_dir/install.sh -c" - break - elif test -f "$ac_dir/shtool"; then - ac_aux_dir=$ac_dir - ac_install_sh="$ac_aux_dir/shtool install -c" - break - fi -done -if test -z "$ac_aux_dir"; then - as_fn_error $? "cannot find install-sh, install.sh, or shtool in \"$srcdir\" \"$srcdir/..\" \"$srcdir/../..\"" "$LINENO" 5 -fi - -# These three variables are undocumented and unsupported, -# and are intended to be withdrawn in a future Autoconf release. -# They can cause serious problems if a builder's source tree is in a directory -# whose full name contains unusual characters. -ac_config_guess="$SHELL $ac_aux_dir/config.guess" # Please don't use this var. -ac_config_sub="$SHELL $ac_aux_dir/config.sub" # Please don't use this var. -ac_configure="$SHELL $ac_aux_dir/configure" # Please don't use this var. - - -# Make sure we can run config.sub. -$SHELL "$ac_aux_dir/config.sub" sun4 >/dev/null 2>&1 || - as_fn_error $? "cannot run $SHELL $ac_aux_dir/config.sub" "$LINENO" 5 - -{ $as_echo "$as_me:${as_lineno-$LINENO}: checking build system type" >&5 -$as_echo_n "checking build system type... " >&6; } -if ${ac_cv_build+:} false; then : - $as_echo_n "(cached) " >&6 -else - ac_build_alias=$build_alias -test "x$ac_build_alias" = x && - ac_build_alias=`$SHELL "$ac_aux_dir/config.guess"` -test "x$ac_build_alias" = x && - as_fn_error $? "cannot guess build type; you must specify one" "$LINENO" 5 -ac_cv_build=`$SHELL "$ac_aux_dir/config.sub" $ac_build_alias` || - as_fn_error $? "$SHELL $ac_aux_dir/config.sub $ac_build_alias failed" "$LINENO" 5 - -fi -{ $as_echo "$as_me:${as_lineno-$LINENO}: result: $ac_cv_build" >&5 -$as_echo "$ac_cv_build" >&6; } -case $ac_cv_build in -*-*-*) ;; -*) as_fn_error $? "invalid value of canonical build" "$LINENO" 5;; -esac -build=$ac_cv_build -ac_save_IFS=$IFS; IFS='-' -set x $ac_cv_build -shift -build_cpu=$1 -build_vendor=$2 -shift; shift -# Remember, the first character of IFS is used to create $*, -# except with old shells: -build_os=$* -IFS=$ac_save_IFS -case $build_os in *\ *) build_os=`echo "$build_os" | sed 's/ /-/g'`;; esac - - - -am__api_version='1.15' - -# Find a good install program. We prefer a C program (faster), -# so one script is as good as another. But avoid the broken or -# incompatible versions: -# SysV /etc/install, /usr/sbin/install -# SunOS /usr/etc/install -# IRIX /sbin/install -# AIX /bin/install -# AmigaOS /C/install, which installs bootblocks on floppy discs -# AIX 4 /usr/bin/installbsd, which doesn't work without a -g flag -# AFS /usr/afsws/bin/install, which mishandles nonexistent args -# SVR4 /usr/ucb/install, which tries to use the nonexistent group "staff" -# OS/2's system install, which has a completely different semantic -# ./install, which can be erroneously created by make from ./install.sh. -# Reject install programs that cannot install multiple files. -{ $as_echo "$as_me:${as_lineno-$LINENO}: checking for a BSD-compatible install" >&5 -$as_echo_n "checking for a BSD-compatible install... " >&6; } -if test -z "$INSTALL"; then -if ${ac_cv_path_install+:} false; then : - $as_echo_n "(cached) " >&6 -else - as_save_IFS=$IFS; IFS=$PATH_SEPARATOR -for as_dir in $PATH -do - IFS=$as_save_IFS - test -z "$as_dir" && as_dir=. - # Account for people who put trailing slashes in PATH elements. -case $as_dir/ in @%:@(( - ./ | .// | /[cC]/* | \ - /etc/* | /usr/sbin/* | /usr/etc/* | /sbin/* | /usr/afsws/bin/* | \ - ?:[\\/]os2[\\/]install[\\/]* | ?:[\\/]OS2[\\/]INSTALL[\\/]* | \ - /usr/ucb/* ) ;; - *) - # OSF1 and SCO ODT 3.0 have their own names for install. - # Don't use installbsd from OSF since it installs stuff as root - # by default. - for ac_prog in ginstall scoinst install; do - for ac_exec_ext in '' $ac_executable_extensions; do - if as_fn_executable_p "$as_dir/$ac_prog$ac_exec_ext"; then - if test $ac_prog = install && - grep dspmsg "$as_dir/$ac_prog$ac_exec_ext" >/dev/null 2>&1; then - # AIX install. It has an incompatible calling convention. - : - elif test $ac_prog = install && - grep pwplus "$as_dir/$ac_prog$ac_exec_ext" >/dev/null 2>&1; then - # program-specific install script used by HP pwplus--don't use. - : - else - rm -rf conftest.one conftest.two conftest.dir - echo one > conftest.one - echo two > conftest.two - mkdir conftest.dir - if "$as_dir/$ac_prog$ac_exec_ext" -c conftest.one conftest.two "`pwd`/conftest.dir" && - test -s conftest.one && test -s conftest.two && - test -s conftest.dir/conftest.one && - test -s conftest.dir/conftest.two - then - ac_cv_path_install="$as_dir/$ac_prog$ac_exec_ext -c" - break 3 - fi - fi - fi - done - done - ;; -esac - - done -IFS=$as_save_IFS - -rm -rf conftest.one conftest.two conftest.dir - -fi - if test "${ac_cv_path_install+set}" = set; then - INSTALL=$ac_cv_path_install - else - # As a last resort, use the slow shell script. Don't cache a - # value for INSTALL within a source directory, because that will - # break other packages using the cache if that directory is - # removed, or if the value is a relative name. - INSTALL=$ac_install_sh - fi -fi -{ $as_echo "$as_me:${as_lineno-$LINENO}: result: $INSTALL" >&5 -$as_echo "$INSTALL" >&6; } - -# Use test -z because SunOS4 sh mishandles braces in ${var-val}. -# It thinks the first close brace ends the variable substitution. -test -z "$INSTALL_PROGRAM" && INSTALL_PROGRAM='${INSTALL}' - -test -z "$INSTALL_SCRIPT" && INSTALL_SCRIPT='${INSTALL}' - -test -z "$INSTALL_DATA" && INSTALL_DATA='${INSTALL} -m 644' - -{ $as_echo "$as_me:${as_lineno-$LINENO}: checking whether build environment is sane" >&5 -$as_echo_n "checking whether build environment is sane... " >&6; } -# Reject unsafe characters in $srcdir or the absolute working directory -# name. Accept space and tab only in the latter. -am_lf=' -' -case `pwd` in - *[\\\"\#\$\&\'\`$am_lf]*) - as_fn_error $? "unsafe absolute working directory name" "$LINENO" 5;; -esac -case $srcdir in - *[\\\"\#\$\&\'\`$am_lf\ \ ]*) - as_fn_error $? "unsafe srcdir value: '$srcdir'" "$LINENO" 5;; -esac - -# Do 'set' in a subshell so we don't clobber the current shell's -# arguments. Must try -L first in case configure is actually a -# symlink; some systems play weird games with the mod time of symlinks -# (eg FreeBSD returns the mod time of the symlink's containing -# directory). -if ( - am_has_slept=no - for am_try in 1 2; do - echo "timestamp, slept: $am_has_slept" > conftest.file - set X `ls -Lt "$srcdir/configure" conftest.file 2> /dev/null` - if test "$*" = "X"; then - # -L didn't work. - set X `ls -t "$srcdir/configure" conftest.file` - fi - if test "$*" != "X $srcdir/configure conftest.file" \ - && test "$*" != "X conftest.file $srcdir/configure"; then - - # If neither matched, then we have a broken ls. This can happen - # if, for instance, CONFIG_SHELL is bash and it inherits a - # broken ls alias from the environment. This has actually - # happened. Such a system could not be considered "sane". - as_fn_error $? "ls -t appears to fail. Make sure there is not a broken - alias in your environment" "$LINENO" 5 - fi - if test "$2" = conftest.file || test $am_try -eq 2; then - break - fi - # Just in case. - sleep 1 - am_has_slept=yes - done - test "$2" = conftest.file - ) -then - # Ok. - : -else - as_fn_error $? "newly created file is older than distributed files! -Check your system clock" "$LINENO" 5 -fi -{ $as_echo "$as_me:${as_lineno-$LINENO}: result: yes" >&5 -$as_echo "yes" >&6; } -# If we didn't sleep, we still need to ensure time stamps of config.status and -# generated files are strictly newer. -am_sleep_pid= -if grep 'slept: no' conftest.file >/dev/null 2>&1; then - ( sleep 1 ) & - am_sleep_pid=$! -fi - -rm -f conftest.file - -test "$program_prefix" != NONE && - program_transform_name="s&^&$program_prefix&;$program_transform_name" -# Use a double $ so make ignores it. -test "$program_suffix" != NONE && - program_transform_name="s&\$&$program_suffix&;$program_transform_name" -# Double any \ or $. -# By default was `s,x,x', remove it if useless. -ac_script='s/[\\$]/&&/g;s/;s,x,x,$//' -program_transform_name=`$as_echo "$program_transform_name" | sed "$ac_script"` - -# Expand $ac_aux_dir to an absolute path. -am_aux_dir=`cd "$ac_aux_dir" && pwd` - -if test x"${MISSING+set}" != xset; then - case $am_aux_dir in - *\ * | *\ *) - MISSING="\${SHELL} \"$am_aux_dir/missing\"" ;; - *) - MISSING="\${SHELL} $am_aux_dir/missing" ;; - esac -fi -# Use eval to expand $SHELL -if eval "$MISSING --is-lightweight"; then - am_missing_run="$MISSING " -else - am_missing_run= - { $as_echo "$as_me:${as_lineno-$LINENO}: WARNING: 'missing' script is too old or missing" >&5 -$as_echo "$as_me: WARNING: 'missing' script is too old or missing" >&2;} -fi - -if test x"${install_sh+set}" != xset; then - case $am_aux_dir in - *\ * | *\ *) - install_sh="\${SHELL} '$am_aux_dir/install-sh'" ;; - *) - install_sh="\${SHELL} $am_aux_dir/install-sh" - esac -fi - -# Installed binaries are usually stripped using 'strip' when the user -# run "make install-strip". However 'strip' might not be the right -# tool to use in cross-compilation environments, therefore Automake -# will honor the 'STRIP' environment variable to overrule this program. -if test "$cross_compiling" != no; then - if test -n "$ac_tool_prefix"; then - # Extract the first word of "${ac_tool_prefix}strip", so it can be a program name with args. -set dummy ${ac_tool_prefix}strip; ac_word=$2 -{ $as_echo "$as_me:${as_lineno-$LINENO}: checking for $ac_word" >&5 -$as_echo_n "checking for $ac_word... " >&6; } -if ${ac_cv_prog_STRIP+:} false; then : - $as_echo_n "(cached) " >&6 -else - if test -n "$STRIP"; then - ac_cv_prog_STRIP="$STRIP" # Let the user override the test. -else -as_save_IFS=$IFS; IFS=$PATH_SEPARATOR -for as_dir in $PATH -do - IFS=$as_save_IFS - test -z "$as_dir" && as_dir=. - for ac_exec_ext in '' $ac_executable_extensions; do - if as_fn_executable_p "$as_dir/$ac_word$ac_exec_ext"; then - ac_cv_prog_STRIP="${ac_tool_prefix}strip" - $as_echo "$as_me:${as_lineno-$LINENO}: found $as_dir/$ac_word$ac_exec_ext" >&5 - break 2 - fi -done - done -IFS=$as_save_IFS - -fi -fi -STRIP=$ac_cv_prog_STRIP -if test -n "$STRIP"; then - { $as_echo "$as_me:${as_lineno-$LINENO}: result: $STRIP" >&5 -$as_echo "$STRIP" >&6; } -else - { $as_echo "$as_me:${as_lineno-$LINENO}: result: no" >&5 -$as_echo "no" >&6; } -fi - - -fi -if test -z "$ac_cv_prog_STRIP"; then - ac_ct_STRIP=$STRIP - # Extract the first word of "strip", so it can be a program name with args. -set dummy strip; ac_word=$2 -{ $as_echo "$as_me:${as_lineno-$LINENO}: checking for $ac_word" >&5 -$as_echo_n "checking for $ac_word... " >&6; } -if ${ac_cv_prog_ac_ct_STRIP+:} false; then : - $as_echo_n "(cached) " >&6 -else - if test -n "$ac_ct_STRIP"; then - ac_cv_prog_ac_ct_STRIP="$ac_ct_STRIP" # Let the user override the test. -else -as_save_IFS=$IFS; IFS=$PATH_SEPARATOR -for as_dir in $PATH -do - IFS=$as_save_IFS - test -z "$as_dir" && as_dir=. - for ac_exec_ext in '' $ac_executable_extensions; do - if as_fn_executable_p "$as_dir/$ac_word$ac_exec_ext"; then - ac_cv_prog_ac_ct_STRIP="strip" - $as_echo "$as_me:${as_lineno-$LINENO}: found $as_dir/$ac_word$ac_exec_ext" >&5 - break 2 - fi -done - done -IFS=$as_save_IFS - -fi -fi -ac_ct_STRIP=$ac_cv_prog_ac_ct_STRIP -if test -n "$ac_ct_STRIP"; then - { $as_echo "$as_me:${as_lineno-$LINENO}: result: $ac_ct_STRIP" >&5 -$as_echo "$ac_ct_STRIP" >&6; } -else - { $as_echo "$as_me:${as_lineno-$LINENO}: result: no" >&5 -$as_echo "no" >&6; } -fi - - if test "x$ac_ct_STRIP" = x; then - STRIP=":" - else - case $cross_compiling:$ac_tool_warned in -yes:) -{ $as_echo "$as_me:${as_lineno-$LINENO}: WARNING: using cross tools not prefixed with host triplet" >&5 -$as_echo "$as_me: WARNING: using cross tools not prefixed with host triplet" >&2;} -ac_tool_warned=yes ;; -esac - STRIP=$ac_ct_STRIP - fi -else - STRIP="$ac_cv_prog_STRIP" -fi - -fi -INSTALL_STRIP_PROGRAM="\$(install_sh) -c -s" - -{ $as_echo "$as_me:${as_lineno-$LINENO}: checking for a thread-safe mkdir -p" >&5 -$as_echo_n "checking for a thread-safe mkdir -p... " >&6; } -if test -z "$MKDIR_P"; then - if ${ac_cv_path_mkdir+:} false; then : - $as_echo_n "(cached) " >&6 -else - as_save_IFS=$IFS; IFS=$PATH_SEPARATOR -for as_dir in $PATH$PATH_SEPARATOR/opt/sfw/bin -do - IFS=$as_save_IFS - test -z "$as_dir" && as_dir=. - for ac_prog in mkdir gmkdir; do - for ac_exec_ext in '' $ac_executable_extensions; do - as_fn_executable_p "$as_dir/$ac_prog$ac_exec_ext" || continue - case `"$as_dir/$ac_prog$ac_exec_ext" --version 2>&1` in #( - 'mkdir (GNU coreutils) '* | \ - 'mkdir (coreutils) '* | \ - 'mkdir (fileutils) '4.1*) - ac_cv_path_mkdir=$as_dir/$ac_prog$ac_exec_ext - break 3;; - esac - done - done - done -IFS=$as_save_IFS - -fi - - test -d ./--version && rmdir ./--version - if test "${ac_cv_path_mkdir+set}" = set; then - MKDIR_P="$ac_cv_path_mkdir -p" - else - # As a last resort, use the slow shell script. Don't cache a - # value for MKDIR_P within a source directory, because that will - # break other packages using the cache if that directory is - # removed, or if the value is a relative name. - MKDIR_P="$ac_install_sh -d" - fi -fi -{ $as_echo "$as_me:${as_lineno-$LINENO}: result: $MKDIR_P" >&5 -$as_echo "$MKDIR_P" >&6; } - -for ac_prog in gawk mawk nawk awk -do - # Extract the first word of "$ac_prog", so it can be a program name with args. -set dummy $ac_prog; ac_word=$2 -{ $as_echo "$as_me:${as_lineno-$LINENO}: checking for $ac_word" >&5 -$as_echo_n "checking for $ac_word... " >&6; } -if ${ac_cv_prog_AWK+:} false; then : - $as_echo_n "(cached) " >&6 -else - if test -n "$AWK"; then - ac_cv_prog_AWK="$AWK" # Let the user override the test. -else -as_save_IFS=$IFS; IFS=$PATH_SEPARATOR -for as_dir in $PATH -do - IFS=$as_save_IFS - test -z "$as_dir" && as_dir=. - for ac_exec_ext in '' $ac_executable_extensions; do - if as_fn_executable_p "$as_dir/$ac_word$ac_exec_ext"; then - ac_cv_prog_AWK="$ac_prog" - $as_echo "$as_me:${as_lineno-$LINENO}: found $as_dir/$ac_word$ac_exec_ext" >&5 - break 2 - fi -done - done -IFS=$as_save_IFS - -fi -fi -AWK=$ac_cv_prog_AWK -if test -n "$AWK"; then - { $as_echo "$as_me:${as_lineno-$LINENO}: result: $AWK" >&5 -$as_echo "$AWK" >&6; } -else - { $as_echo "$as_me:${as_lineno-$LINENO}: result: no" >&5 -$as_echo "no" >&6; } -fi - - - test -n "$AWK" && break -done - -{ $as_echo "$as_me:${as_lineno-$LINENO}: checking whether ${MAKE-make} sets \$(MAKE)" >&5 -$as_echo_n "checking whether ${MAKE-make} sets \$(MAKE)... " >&6; } -set x ${MAKE-make} -ac_make=`$as_echo "$2" | sed 's/+/p/g; s/[^a-zA-Z0-9_]/_/g'` -if eval \${ac_cv_prog_make_${ac_make}_set+:} false; then : - $as_echo_n "(cached) " >&6 -else - cat >conftest.make <<\_ACEOF -SHELL = /bin/sh -all: - @echo '@@@%%%=$(MAKE)=@@@%%%' -_ACEOF -# GNU make sometimes prints "make[1]: Entering ...", which would confuse us. -case `${MAKE-make} -f conftest.make 2>/dev/null` in - *@@@%%%=?*=@@@%%%*) - eval ac_cv_prog_make_${ac_make}_set=yes;; - *) - eval ac_cv_prog_make_${ac_make}_set=no;; -esac -rm -f conftest.make -fi -if eval test \$ac_cv_prog_make_${ac_make}_set = yes; then - { $as_echo "$as_me:${as_lineno-$LINENO}: result: yes" >&5 -$as_echo "yes" >&6; } - SET_MAKE= -else - { $as_echo "$as_me:${as_lineno-$LINENO}: result: no" >&5 -$as_echo "no" >&6; } - SET_MAKE="MAKE=${MAKE-make}" -fi - -rm -rf .tst 2>/dev/null -mkdir .tst 2>/dev/null -if test -d .tst; then - am__leading_dot=. -else - am__leading_dot=_ -fi -rmdir .tst 2>/dev/null - -@%:@ Check whether --enable-silent-rules was given. -if test "${enable_silent_rules+set}" = set; then : - enableval=$enable_silent_rules; -fi - -case $enable_silent_rules in @%:@ ((( - yes) AM_DEFAULT_VERBOSITY=0;; - no) AM_DEFAULT_VERBOSITY=1;; - *) AM_DEFAULT_VERBOSITY=1;; -esac -am_make=${MAKE-make} -{ $as_echo "$as_me:${as_lineno-$LINENO}: checking whether $am_make supports nested variables" >&5 -$as_echo_n "checking whether $am_make supports nested variables... " >&6; } -if ${am_cv_make_support_nested_variables+:} false; then : - $as_echo_n "(cached) " >&6 -else - if $as_echo 'TRUE=$(BAR$(V)) -BAR0=false -BAR1=true -V=1 -am__doit: - @$(TRUE) -.PHONY: am__doit' | $am_make -f - >/dev/null 2>&1; then - am_cv_make_support_nested_variables=yes -else - am_cv_make_support_nested_variables=no -fi -fi -{ $as_echo "$as_me:${as_lineno-$LINENO}: result: $am_cv_make_support_nested_variables" >&5 -$as_echo "$am_cv_make_support_nested_variables" >&6; } -if test $am_cv_make_support_nested_variables = yes; then - AM_V='$(V)' - AM_DEFAULT_V='$(AM_DEFAULT_VERBOSITY)' -else - AM_V=$AM_DEFAULT_VERBOSITY - AM_DEFAULT_V=$AM_DEFAULT_VERBOSITY -fi -AM_BACKSLASH='\' - -if test "`cd $srcdir && pwd`" != "`pwd`"; then - # Use -I$(srcdir) only when $(srcdir) != ., so that make's output - # is not polluted with repeated "-I." - am__isrc=' -I$(srcdir)' - # test to see if srcdir already configured - if test -f $srcdir/config.status; then - as_fn_error $? "source directory already configured; run \"make distclean\" there first" "$LINENO" 5 - fi -fi - -# test whether we have cygpath -if test -z "$CYGPATH_W"; then - if (cygpath --version) >/dev/null 2>/dev/null; then - CYGPATH_W='cygpath -w' - else - CYGPATH_W=echo - fi -fi - - -# Define the identity of the package. - PACKAGE='munipack' - VERSION='0.5.9' - - -cat >>confdefs.h <<_ACEOF -@%:@define PACKAGE "$PACKAGE" -_ACEOF - - -cat >>confdefs.h <<_ACEOF -@%:@define VERSION "$VERSION" -_ACEOF - -# Some tools Automake needs. - -ACLOCAL=${ACLOCAL-"${am_missing_run}aclocal-${am__api_version}"} - - -AUTOCONF=${AUTOCONF-"${am_missing_run}autoconf"} - - -AUTOMAKE=${AUTOMAKE-"${am_missing_run}automake-${am__api_version}"} - - -AUTOHEADER=${AUTOHEADER-"${am_missing_run}autoheader"} - - -MAKEINFO=${MAKEINFO-"${am_missing_run}makeinfo"} - -# For better backward compatibility. To be removed once Automake 1.9.x -# dies out for good. For more background, see: -# -# -mkdir_p='$(MKDIR_P)' - -# We need awk for the "check" target (and possibly the TAP driver). The -# system "awk" is bad on some platforms. -# Always define AMTAR for backward compatibility. Yes, it's still used -# in the wild :-( We should find a proper way to deprecate it ... -AMTAR='$${TAR-tar}' - - -# We'll loop over all known methods to create a tar archive until one works. -_am_tools='gnutar pax cpio none' - -am__tar='$${TAR-tar} chof - "$$tardir"' am__untar='$${TAR-tar} xf -' - - - - - - -# POSIX will say in a future version that running "rm -f" with no argument -# is OK; and we want to be able to make that assumption in our Makefile -# recipes. So use an aggressive probe to check that the usage we want is -# actually supported "in the wild" to an acceptable degree. -# See automake bug#10828. -# To make any issue more visible, cause the running configure to be aborted -# by default if the 'rm' program in use doesn't match our expectations; the -# user can still override this though. -if rm -f && rm -fr && rm -rf; then : OK; else - cat >&2 <<'END' -Oops! - -Your 'rm' program seems unable to run without file operands specified -on the command line, even when the '-f' option is present. This is contrary -to the behaviour of most rm programs out there, and not conforming with -the upcoming POSIX standard: - -Please tell bug-automake@gnu.org about your system, including the value -of your $PATH and any error possibly output before this message. This -can help us improve future automake versions. - -END - if test x"$ACCEPT_INFERIOR_RM_PROGRAM" = x"yes"; then - echo 'Configuration will proceed anyway, since you have set the' >&2 - echo 'ACCEPT_INFERIOR_RM_PROGRAM variable to "yes"' >&2 - echo >&2 - else - cat >&2 <<'END' -Aborting the configuration process, to ensure you take notice of the issue. - -You can download and install GNU coreutils to get an 'rm' implementation -that behaves properly: . - -If you want to complete the configuration process using your problematic -'rm' anyway, export the environment variable ACCEPT_INFERIOR_RM_PROGRAM -to "yes", and re-run configure. - -END - as_fn_error $? "Your 'rm' program is bad, sorry." "$LINENO" 5 - fi -fi - - -ac_ext=c -ac_cpp='$CPP $CPPFLAGS' -ac_compile='$CC -c $CFLAGS $CPPFLAGS conftest.$ac_ext >&5' -ac_link='$CC -o conftest$ac_exeext $CFLAGS $CPPFLAGS $LDFLAGS conftest.$ac_ext $LIBS >&5' -ac_compiler_gnu=$ac_cv_c_compiler_gnu -if test -n "$ac_tool_prefix"; then - # Extract the first word of "${ac_tool_prefix}gcc", so it can be a program name with args. -set dummy ${ac_tool_prefix}gcc; ac_word=$2 -{ $as_echo "$as_me:${as_lineno-$LINENO}: checking for $ac_word" >&5 -$as_echo_n "checking for $ac_word... " >&6; } -if ${ac_cv_prog_CC+:} false; then : - $as_echo_n "(cached) " >&6 -else - if test -n "$CC"; then - ac_cv_prog_CC="$CC" # Let the user override the test. -else -as_save_IFS=$IFS; IFS=$PATH_SEPARATOR -for as_dir in $PATH -do - IFS=$as_save_IFS - test -z "$as_dir" && as_dir=. - for ac_exec_ext in '' $ac_executable_extensions; do - if as_fn_executable_p "$as_dir/$ac_word$ac_exec_ext"; then - ac_cv_prog_CC="${ac_tool_prefix}gcc" - $as_echo "$as_me:${as_lineno-$LINENO}: found $as_dir/$ac_word$ac_exec_ext" >&5 - break 2 - fi -done - done -IFS=$as_save_IFS - -fi -fi -CC=$ac_cv_prog_CC -if test -n "$CC"; then - { $as_echo "$as_me:${as_lineno-$LINENO}: result: $CC" >&5 -$as_echo "$CC" >&6; } -else - { $as_echo "$as_me:${as_lineno-$LINENO}: result: no" >&5 -$as_echo "no" >&6; } -fi - - -fi -if test -z "$ac_cv_prog_CC"; then - ac_ct_CC=$CC - # Extract the first word of "gcc", so it can be a program name with args. -set dummy gcc; ac_word=$2 -{ $as_echo "$as_me:${as_lineno-$LINENO}: checking for $ac_word" >&5 -$as_echo_n "checking for $ac_word... " >&6; } -if ${ac_cv_prog_ac_ct_CC+:} false; then : - $as_echo_n "(cached) " >&6 -else - if test -n "$ac_ct_CC"; then - ac_cv_prog_ac_ct_CC="$ac_ct_CC" # Let the user override the test. -else -as_save_IFS=$IFS; IFS=$PATH_SEPARATOR -for as_dir in $PATH -do - IFS=$as_save_IFS - test -z "$as_dir" && as_dir=. - for ac_exec_ext in '' $ac_executable_extensions; do - if as_fn_executable_p "$as_dir/$ac_word$ac_exec_ext"; then - ac_cv_prog_ac_ct_CC="gcc" - $as_echo "$as_me:${as_lineno-$LINENO}: found $as_dir/$ac_word$ac_exec_ext" >&5 - break 2 - fi -done - done -IFS=$as_save_IFS - -fi -fi -ac_ct_CC=$ac_cv_prog_ac_ct_CC -if test -n "$ac_ct_CC"; then - { $as_echo "$as_me:${as_lineno-$LINENO}: result: $ac_ct_CC" >&5 -$as_echo "$ac_ct_CC" >&6; } -else - { $as_echo "$as_me:${as_lineno-$LINENO}: result: no" >&5 -$as_echo "no" >&6; } -fi - - if test "x$ac_ct_CC" = x; then - CC="" - else - case $cross_compiling:$ac_tool_warned in -yes:) -{ $as_echo "$as_me:${as_lineno-$LINENO}: WARNING: using cross tools not prefixed with host triplet" >&5 -$as_echo "$as_me: WARNING: using cross tools not prefixed with host triplet" >&2;} -ac_tool_warned=yes ;; -esac - CC=$ac_ct_CC - fi -else - CC="$ac_cv_prog_CC" -fi - -if test -z "$CC"; then - if test -n "$ac_tool_prefix"; then - # Extract the first word of "${ac_tool_prefix}cc", so it can be a program name with args. -set dummy ${ac_tool_prefix}cc; ac_word=$2 -{ $as_echo "$as_me:${as_lineno-$LINENO}: checking for $ac_word" >&5 -$as_echo_n "checking for $ac_word... " >&6; } -if ${ac_cv_prog_CC+:} false; then : - $as_echo_n "(cached) " >&6 -else - if test -n "$CC"; then - ac_cv_prog_CC="$CC" # Let the user override the test. -else -as_save_IFS=$IFS; IFS=$PATH_SEPARATOR -for as_dir in $PATH -do - IFS=$as_save_IFS - test -z "$as_dir" && as_dir=. - for ac_exec_ext in '' $ac_executable_extensions; do - if as_fn_executable_p "$as_dir/$ac_word$ac_exec_ext"; then - ac_cv_prog_CC="${ac_tool_prefix}cc" - $as_echo "$as_me:${as_lineno-$LINENO}: found $as_dir/$ac_word$ac_exec_ext" >&5 - break 2 - fi -done - done -IFS=$as_save_IFS - -fi -fi -CC=$ac_cv_prog_CC -if test -n "$CC"; then - { $as_echo "$as_me:${as_lineno-$LINENO}: result: $CC" >&5 -$as_echo "$CC" >&6; } -else - { $as_echo "$as_me:${as_lineno-$LINENO}: result: no" >&5 -$as_echo "no" >&6; } -fi - - - fi -fi -if test -z "$CC"; then - # Extract the first word of "cc", so it can be a program name with args. -set dummy cc; ac_word=$2 -{ $as_echo "$as_me:${as_lineno-$LINENO}: checking for $ac_word" >&5 -$as_echo_n "checking for $ac_word... " >&6; } -if ${ac_cv_prog_CC+:} false; then : - $as_echo_n "(cached) " >&6 -else - if test -n "$CC"; then - ac_cv_prog_CC="$CC" # Let the user override the test. -else - ac_prog_rejected=no -as_save_IFS=$IFS; IFS=$PATH_SEPARATOR -for as_dir in $PATH -do - IFS=$as_save_IFS - test -z "$as_dir" && as_dir=. - for ac_exec_ext in '' $ac_executable_extensions; do - if as_fn_executable_p "$as_dir/$ac_word$ac_exec_ext"; then - if test "$as_dir/$ac_word$ac_exec_ext" = "/usr/ucb/cc"; then - ac_prog_rejected=yes - continue - fi - ac_cv_prog_CC="cc" - $as_echo "$as_me:${as_lineno-$LINENO}: found $as_dir/$ac_word$ac_exec_ext" >&5 - break 2 - fi -done - done -IFS=$as_save_IFS - -if test $ac_prog_rejected = yes; then - # We found a bogon in the path, so make sure we never use it. - set dummy $ac_cv_prog_CC - shift - if test $@%:@ != 0; then - # We chose a different compiler from the bogus one. - # However, it has the same basename, so the bogon will be chosen - # first if we set CC to just the basename; use the full file name. - shift - ac_cv_prog_CC="$as_dir/$ac_word${1+' '}$@" - fi -fi -fi -fi -CC=$ac_cv_prog_CC -if test -n "$CC"; then - { $as_echo "$as_me:${as_lineno-$LINENO}: result: $CC" >&5 -$as_echo "$CC" >&6; } -else - { $as_echo "$as_me:${as_lineno-$LINENO}: result: no" >&5 -$as_echo "no" >&6; } -fi - - -fi -if test -z "$CC"; then - if test -n "$ac_tool_prefix"; then - for ac_prog in cl.exe - do - # Extract the first word of "$ac_tool_prefix$ac_prog", so it can be a program name with args. -set dummy $ac_tool_prefix$ac_prog; ac_word=$2 -{ $as_echo "$as_me:${as_lineno-$LINENO}: checking for $ac_word" >&5 -$as_echo_n "checking for $ac_word... " >&6; } -if ${ac_cv_prog_CC+:} false; then : - $as_echo_n "(cached) " >&6 -else - if test -n "$CC"; then - ac_cv_prog_CC="$CC" # Let the user override the test. -else -as_save_IFS=$IFS; IFS=$PATH_SEPARATOR -for as_dir in $PATH -do - IFS=$as_save_IFS - test -z "$as_dir" && as_dir=. - for ac_exec_ext in '' $ac_executable_extensions; do - if as_fn_executable_p "$as_dir/$ac_word$ac_exec_ext"; then - ac_cv_prog_CC="$ac_tool_prefix$ac_prog" - $as_echo "$as_me:${as_lineno-$LINENO}: found $as_dir/$ac_word$ac_exec_ext" >&5 - break 2 - fi -done - done -IFS=$as_save_IFS - -fi -fi -CC=$ac_cv_prog_CC -if test -n "$CC"; then - { $as_echo "$as_me:${as_lineno-$LINENO}: result: $CC" >&5 -$as_echo "$CC" >&6; } -else - { $as_echo "$as_me:${as_lineno-$LINENO}: result: no" >&5 -$as_echo "no" >&6; } -fi - - - test -n "$CC" && break - done -fi -if test -z "$CC"; then - ac_ct_CC=$CC - for ac_prog in cl.exe -do - # Extract the first word of "$ac_prog", so it can be a program name with args. -set dummy $ac_prog; ac_word=$2 -{ $as_echo "$as_me:${as_lineno-$LINENO}: checking for $ac_word" >&5 -$as_echo_n "checking for $ac_word... " >&6; } -if ${ac_cv_prog_ac_ct_CC+:} false; then : - $as_echo_n "(cached) " >&6 -else - if test -n "$ac_ct_CC"; then - ac_cv_prog_ac_ct_CC="$ac_ct_CC" # Let the user override the test. -else -as_save_IFS=$IFS; IFS=$PATH_SEPARATOR -for as_dir in $PATH -do - IFS=$as_save_IFS - test -z "$as_dir" && as_dir=. - for ac_exec_ext in '' $ac_executable_extensions; do - if as_fn_executable_p "$as_dir/$ac_word$ac_exec_ext"; then - ac_cv_prog_ac_ct_CC="$ac_prog" - $as_echo "$as_me:${as_lineno-$LINENO}: found $as_dir/$ac_word$ac_exec_ext" >&5 - break 2 - fi -done - done -IFS=$as_save_IFS - -fi -fi -ac_ct_CC=$ac_cv_prog_ac_ct_CC -if test -n "$ac_ct_CC"; then - { $as_echo "$as_me:${as_lineno-$LINENO}: result: $ac_ct_CC" >&5 -$as_echo "$ac_ct_CC" >&6; } -else - { $as_echo "$as_me:${as_lineno-$LINENO}: result: no" >&5 -$as_echo "no" >&6; } -fi - - - test -n "$ac_ct_CC" && break -done - - if test "x$ac_ct_CC" = x; then - CC="" - else - case $cross_compiling:$ac_tool_warned in -yes:) -{ $as_echo "$as_me:${as_lineno-$LINENO}: WARNING: using cross tools not prefixed with host triplet" >&5 -$as_echo "$as_me: WARNING: using cross tools not prefixed with host triplet" >&2;} -ac_tool_warned=yes ;; -esac - CC=$ac_ct_CC - fi -fi - -fi - - -test -z "$CC" && { { $as_echo "$as_me:${as_lineno-$LINENO}: error: in \`$ac_pwd':" >&5 -$as_echo "$as_me: error: in \`$ac_pwd':" >&2;} -as_fn_error $? "no acceptable C compiler found in \$PATH -See \`config.log' for more details" "$LINENO" 5; } - -# Provide some information about the compiler. -$as_echo "$as_me:${as_lineno-$LINENO}: checking for C compiler version" >&5 -set X $ac_compile -ac_compiler=$2 -for ac_option in --version -v -V -qversion; do - { { ac_try="$ac_compiler $ac_option >&5" -case "(($ac_try" in - *\"* | *\`* | *\\*) ac_try_echo=\$ac_try;; - *) ac_try_echo=$ac_try;; -esac -eval ac_try_echo="\"\$as_me:${as_lineno-$LINENO}: $ac_try_echo\"" -$as_echo "$ac_try_echo"; } >&5 - (eval "$ac_compiler $ac_option >&5") 2>conftest.err - ac_status=$? - if test -s conftest.err; then - sed '10a\ -... rest of stderr output deleted ... - 10q' conftest.err >conftest.er1 - cat conftest.er1 >&5 - fi - rm -f conftest.er1 conftest.err - $as_echo "$as_me:${as_lineno-$LINENO}: \$? = $ac_status" >&5 - test $ac_status = 0; } -done - -cat confdefs.h - <<_ACEOF >conftest.$ac_ext -/* end confdefs.h. */ - -int -main () -{ - - ; - return 0; -} -_ACEOF -ac_clean_files_save=$ac_clean_files -ac_clean_files="$ac_clean_files a.out a.out.dSYM a.exe b.out" -# Try to create an executable without -o first, disregard a.out. -# It will help us diagnose broken compilers, and finding out an intuition -# of exeext. -{ $as_echo "$as_me:${as_lineno-$LINENO}: checking whether the C compiler works" >&5 -$as_echo_n "checking whether the C compiler works... " >&6; } -ac_link_default=`$as_echo "$ac_link" | sed 's/ -o *conftest[^ ]*//'` - -# The possible output files: -ac_files="a.out conftest.exe conftest a.exe a_out.exe b.out conftest.*" - -ac_rmfiles= -for ac_file in $ac_files -do - case $ac_file in - *.$ac_ext | *.xcoff | *.tds | *.d | *.pdb | *.xSYM | *.bb | *.bbg | *.map | *.inf | *.dSYM | *.o | *.obj ) ;; - * ) ac_rmfiles="$ac_rmfiles $ac_file";; - esac -done -rm -f $ac_rmfiles - -if { { ac_try="$ac_link_default" -case "(($ac_try" in - *\"* | *\`* | *\\*) ac_try_echo=\$ac_try;; - *) ac_try_echo=$ac_try;; -esac -eval ac_try_echo="\"\$as_me:${as_lineno-$LINENO}: $ac_try_echo\"" -$as_echo "$ac_try_echo"; } >&5 - (eval "$ac_link_default") 2>&5 - ac_status=$? - $as_echo "$as_me:${as_lineno-$LINENO}: \$? = $ac_status" >&5 - test $ac_status = 0; }; then : - # Autoconf-2.13 could set the ac_cv_exeext variable to `no'. -# So ignore a value of `no', otherwise this would lead to `EXEEXT = no' -# in a Makefile. We should not override ac_cv_exeext if it was cached, -# so that the user can short-circuit this test for compilers unknown to -# Autoconf. -for ac_file in $ac_files '' -do - test -f "$ac_file" || continue - case $ac_file in - *.$ac_ext | *.xcoff | *.tds | *.d | *.pdb | *.xSYM | *.bb | *.bbg | *.map | *.inf | *.dSYM | *.o | *.obj ) - ;; - [ab].out ) - # We found the default executable, but exeext='' is most - # certainly right. - break;; - *.* ) - if test "${ac_cv_exeext+set}" = set && test "$ac_cv_exeext" != no; - then :; else - ac_cv_exeext=`expr "$ac_file" : '[^.]*\(\..*\)'` - fi - # We set ac_cv_exeext here because the later test for it is not - # safe: cross compilers may not add the suffix if given an `-o' - # argument, so we may need to know it at that point already. - # Even if this section looks crufty: it has the advantage of - # actually working. - break;; - * ) - break;; - esac -done -test "$ac_cv_exeext" = no && ac_cv_exeext= - -else - ac_file='' -fi -if test -z "$ac_file"; then : - { $as_echo "$as_me:${as_lineno-$LINENO}: result: no" >&5 -$as_echo "no" >&6; } -$as_echo "$as_me: failed program was:" >&5 -sed 's/^/| /' conftest.$ac_ext >&5 - -{ { $as_echo "$as_me:${as_lineno-$LINENO}: error: in \`$ac_pwd':" >&5 -$as_echo "$as_me: error: in \`$ac_pwd':" >&2;} -as_fn_error 77 "C compiler cannot create executables -See \`config.log' for more details" "$LINENO" 5; } -else - { $as_echo "$as_me:${as_lineno-$LINENO}: result: yes" >&5 -$as_echo "yes" >&6; } -fi -{ $as_echo "$as_me:${as_lineno-$LINENO}: checking for C compiler default output file name" >&5 -$as_echo_n "checking for C compiler default output file name... " >&6; } -{ $as_echo "$as_me:${as_lineno-$LINENO}: result: $ac_file" >&5 -$as_echo "$ac_file" >&6; } -ac_exeext=$ac_cv_exeext - -rm -f -r a.out a.out.dSYM a.exe conftest$ac_cv_exeext b.out -ac_clean_files=$ac_clean_files_save -{ $as_echo "$as_me:${as_lineno-$LINENO}: checking for suffix of executables" >&5 -$as_echo_n "checking for suffix of executables... " >&6; } -if { { ac_try="$ac_link" -case "(($ac_try" in - *\"* | *\`* | *\\*) ac_try_echo=\$ac_try;; - *) ac_try_echo=$ac_try;; -esac -eval ac_try_echo="\"\$as_me:${as_lineno-$LINENO}: $ac_try_echo\"" -$as_echo "$ac_try_echo"; } >&5 - (eval "$ac_link") 2>&5 - ac_status=$? - $as_echo "$as_me:${as_lineno-$LINENO}: \$? = $ac_status" >&5 - test $ac_status = 0; }; then : - # If both `conftest.exe' and `conftest' are `present' (well, observable) -# catch `conftest.exe'. For instance with Cygwin, `ls conftest' will -# work properly (i.e., refer to `conftest.exe'), while it won't with -# `rm'. -for ac_file in conftest.exe conftest conftest.*; do - test -f "$ac_file" || continue - case $ac_file in - *.$ac_ext | *.xcoff | *.tds | *.d | *.pdb | *.xSYM | *.bb | *.bbg | *.map | *.inf | *.dSYM | *.o | *.obj ) ;; - *.* ) ac_cv_exeext=`expr "$ac_file" : '[^.]*\(\..*\)'` - break;; - * ) break;; - esac -done -else - { { $as_echo "$as_me:${as_lineno-$LINENO}: error: in \`$ac_pwd':" >&5 -$as_echo "$as_me: error: in \`$ac_pwd':" >&2;} -as_fn_error $? "cannot compute suffix of executables: cannot compile and link -See \`config.log' for more details" "$LINENO" 5; } -fi -rm -f conftest conftest$ac_cv_exeext -{ $as_echo "$as_me:${as_lineno-$LINENO}: result: $ac_cv_exeext" >&5 -$as_echo "$ac_cv_exeext" >&6; } - -rm -f conftest.$ac_ext -EXEEXT=$ac_cv_exeext -ac_exeext=$EXEEXT -cat confdefs.h - <<_ACEOF >conftest.$ac_ext -/* end confdefs.h. */ -@%:@include -int -main () -{ -FILE *f = fopen ("conftest.out", "w"); - return ferror (f) || fclose (f) != 0; - - ; - return 0; -} -_ACEOF -ac_clean_files="$ac_clean_files conftest.out" -# Check that the compiler produces executables we can run. If not, either -# the compiler is broken, or we cross compile. -{ $as_echo "$as_me:${as_lineno-$LINENO}: checking whether we are cross compiling" >&5 -$as_echo_n "checking whether we are cross compiling... " >&6; } -if test "$cross_compiling" != yes; then - { { ac_try="$ac_link" -case "(($ac_try" in - *\"* | *\`* | *\\*) ac_try_echo=\$ac_try;; - *) ac_try_echo=$ac_try;; -esac -eval ac_try_echo="\"\$as_me:${as_lineno-$LINENO}: $ac_try_echo\"" -$as_echo "$ac_try_echo"; } >&5 - (eval "$ac_link") 2>&5 - ac_status=$? - $as_echo "$as_me:${as_lineno-$LINENO}: \$? = $ac_status" >&5 - test $ac_status = 0; } - if { ac_try='./conftest$ac_cv_exeext' - { { case "(($ac_try" in - *\"* | *\`* | *\\*) ac_try_echo=\$ac_try;; - *) ac_try_echo=$ac_try;; -esac -eval ac_try_echo="\"\$as_me:${as_lineno-$LINENO}: $ac_try_echo\"" -$as_echo "$ac_try_echo"; } >&5 - (eval "$ac_try") 2>&5 - ac_status=$? - $as_echo "$as_me:${as_lineno-$LINENO}: \$? = $ac_status" >&5 - test $ac_status = 0; }; }; then - cross_compiling=no - else - if test "$cross_compiling" = maybe; then - cross_compiling=yes - else - { { $as_echo "$as_me:${as_lineno-$LINENO}: error: in \`$ac_pwd':" >&5 -$as_echo "$as_me: error: in \`$ac_pwd':" >&2;} -as_fn_error $? "cannot run C compiled programs. -If you meant to cross compile, use \`--host'. -See \`config.log' for more details" "$LINENO" 5; } - fi - fi -fi -{ $as_echo "$as_me:${as_lineno-$LINENO}: result: $cross_compiling" >&5 -$as_echo "$cross_compiling" >&6; } - -rm -f conftest.$ac_ext conftest$ac_cv_exeext conftest.out -ac_clean_files=$ac_clean_files_save -{ $as_echo "$as_me:${as_lineno-$LINENO}: checking for suffix of object files" >&5 -$as_echo_n "checking for suffix of object files... " >&6; } -if ${ac_cv_objext+:} false; then : - $as_echo_n "(cached) " >&6 -else - cat confdefs.h - <<_ACEOF >conftest.$ac_ext -/* end confdefs.h. */ - -int -main () -{ - - ; - return 0; -} -_ACEOF -rm -f conftest.o conftest.obj -if { { ac_try="$ac_compile" -case "(($ac_try" in - *\"* | *\`* | *\\*) ac_try_echo=\$ac_try;; - *) ac_try_echo=$ac_try;; -esac -eval ac_try_echo="\"\$as_me:${as_lineno-$LINENO}: $ac_try_echo\"" -$as_echo "$ac_try_echo"; } >&5 - (eval "$ac_compile") 2>&5 - ac_status=$? - $as_echo "$as_me:${as_lineno-$LINENO}: \$? = $ac_status" >&5 - test $ac_status = 0; }; then : - for ac_file in conftest.o conftest.obj conftest.*; do - test -f "$ac_file" || continue; - case $ac_file in - *.$ac_ext | *.xcoff | *.tds | *.d | *.pdb | *.xSYM | *.bb | *.bbg | *.map | *.inf | *.dSYM ) ;; - *) ac_cv_objext=`expr "$ac_file" : '.*\.\(.*\)'` - break;; - esac -done -else - $as_echo "$as_me: failed program was:" >&5 -sed 's/^/| /' conftest.$ac_ext >&5 - -{ { $as_echo "$as_me:${as_lineno-$LINENO}: error: in \`$ac_pwd':" >&5 -$as_echo "$as_me: error: in \`$ac_pwd':" >&2;} -as_fn_error $? "cannot compute suffix of object files: cannot compile -See \`config.log' for more details" "$LINENO" 5; } -fi -rm -f conftest.$ac_cv_objext conftest.$ac_ext -fi -{ $as_echo "$as_me:${as_lineno-$LINENO}: result: $ac_cv_objext" >&5 -$as_echo "$ac_cv_objext" >&6; } -OBJEXT=$ac_cv_objext -ac_objext=$OBJEXT -{ $as_echo "$as_me:${as_lineno-$LINENO}: checking whether we are using the GNU C compiler" >&5 -$as_echo_n "checking whether we are using the GNU C compiler... " >&6; } -if ${ac_cv_c_compiler_gnu+:} false; then : - $as_echo_n "(cached) " >&6 -else - cat confdefs.h - <<_ACEOF >conftest.$ac_ext -/* end confdefs.h. */ - -int -main () -{ -#ifndef __GNUC__ - choke me -#endif - - ; - return 0; -} -_ACEOF -if ac_fn_c_try_compile "$LINENO"; then : - ac_compiler_gnu=yes -else - ac_compiler_gnu=no -fi -rm -f core conftest.err conftest.$ac_objext conftest.$ac_ext -ac_cv_c_compiler_gnu=$ac_compiler_gnu - -fi -{ $as_echo "$as_me:${as_lineno-$LINENO}: result: $ac_cv_c_compiler_gnu" >&5 -$as_echo "$ac_cv_c_compiler_gnu" >&6; } -if test $ac_compiler_gnu = yes; then - GCC=yes -else - GCC= -fi -ac_test_CFLAGS=${CFLAGS+set} -ac_save_CFLAGS=$CFLAGS -{ $as_echo "$as_me:${as_lineno-$LINENO}: checking whether $CC accepts -g" >&5 -$as_echo_n "checking whether $CC accepts -g... " >&6; } -if ${ac_cv_prog_cc_g+:} false; then : - $as_echo_n "(cached) " >&6 -else - ac_save_c_werror_flag=$ac_c_werror_flag - ac_c_werror_flag=yes - ac_cv_prog_cc_g=no - CFLAGS="-g" - cat confdefs.h - <<_ACEOF >conftest.$ac_ext -/* end confdefs.h. */ - -int -main () -{ - - ; - return 0; -} -_ACEOF -if ac_fn_c_try_compile "$LINENO"; then : - ac_cv_prog_cc_g=yes -else - CFLAGS="" - cat confdefs.h - <<_ACEOF >conftest.$ac_ext -/* end confdefs.h. */ - -int -main () -{ - - ; - return 0; -} -_ACEOF -if ac_fn_c_try_compile "$LINENO"; then : - -else - ac_c_werror_flag=$ac_save_c_werror_flag - CFLAGS="-g" - cat confdefs.h - <<_ACEOF >conftest.$ac_ext -/* end confdefs.h. */ - -int -main () -{ - - ; - return 0; -} -_ACEOF -if ac_fn_c_try_compile "$LINENO"; then : - ac_cv_prog_cc_g=yes -fi -rm -f core conftest.err conftest.$ac_objext conftest.$ac_ext -fi -rm -f core conftest.err conftest.$ac_objext conftest.$ac_ext -fi -rm -f core conftest.err conftest.$ac_objext conftest.$ac_ext - ac_c_werror_flag=$ac_save_c_werror_flag -fi -{ $as_echo "$as_me:${as_lineno-$LINENO}: result: $ac_cv_prog_cc_g" >&5 -$as_echo "$ac_cv_prog_cc_g" >&6; } -if test "$ac_test_CFLAGS" = set; then - CFLAGS=$ac_save_CFLAGS -elif test $ac_cv_prog_cc_g = yes; then - if test "$GCC" = yes; then - CFLAGS="-g -O2" - else - CFLAGS="-g" - fi -else - if test "$GCC" = yes; then - CFLAGS="-O2" - else - CFLAGS= - fi -fi -{ $as_echo "$as_me:${as_lineno-$LINENO}: checking for $CC option to accept ISO C89" >&5 -$as_echo_n "checking for $CC option to accept ISO C89... " >&6; } -if ${ac_cv_prog_cc_c89+:} false; then : - $as_echo_n "(cached) " >&6 -else - ac_cv_prog_cc_c89=no -ac_save_CC=$CC -cat confdefs.h - <<_ACEOF >conftest.$ac_ext -/* end confdefs.h. */ -#include -#include -struct stat; -/* Most of the following tests are stolen from RCS 5.7's src/conf.sh. */ -struct buf { int x; }; -FILE * (*rcsopen) (struct buf *, struct stat *, int); -static char *e (p, i) - char **p; - int i; -{ - return p[i]; -} -static char *f (char * (*g) (char **, int), char **p, ...) -{ - char *s; - va_list v; - va_start (v,p); - s = g (p, va_arg (v,int)); - va_end (v); - return s; -} - -/* OSF 4.0 Compaq cc is some sort of almost-ANSI by default. It has - function prototypes and stuff, but not '\xHH' hex character constants. - These don't provoke an error unfortunately, instead are silently treated - as 'x'. The following induces an error, until -std is added to get - proper ANSI mode. Curiously '\x00'!='x' always comes out true, for an - array size at least. It's necessary to write '\x00'==0 to get something - that's true only with -std. */ -int osf4_cc_array ['\x00' == 0 ? 1 : -1]; - -/* IBM C 6 for AIX is almost-ANSI by default, but it replaces macro parameters - inside strings and character constants. */ -#define FOO(x) 'x' -int xlc6_cc_array[FOO(a) == 'x' ? 1 : -1]; - -int test (int i, double x); -struct s1 {int (*f) (int a);}; -struct s2 {int (*f) (double a);}; -int pairnames (int, char **, FILE *(*)(struct buf *, struct stat *, int), int, int); -int argc; -char **argv; -int -main () -{ -return f (e, argv, 0) != argv[0] || f (e, argv, 1) != argv[1]; - ; - return 0; -} -_ACEOF -for ac_arg in '' -qlanglvl=extc89 -qlanglvl=ansi -std \ - -Ae "-Aa -D_HPUX_SOURCE" "-Xc -D__EXTENSIONS__" -do - CC="$ac_save_CC $ac_arg" - if ac_fn_c_try_compile "$LINENO"; then : - ac_cv_prog_cc_c89=$ac_arg -fi -rm -f core conftest.err conftest.$ac_objext - test "x$ac_cv_prog_cc_c89" != "xno" && break -done -rm -f conftest.$ac_ext -CC=$ac_save_CC - -fi -# AC_CACHE_VAL -case "x$ac_cv_prog_cc_c89" in - x) - { $as_echo "$as_me:${as_lineno-$LINENO}: result: none needed" >&5 -$as_echo "none needed" >&6; } ;; - xno) - { $as_echo "$as_me:${as_lineno-$LINENO}: result: unsupported" >&5 -$as_echo "unsupported" >&6; } ;; - *) - CC="$CC $ac_cv_prog_cc_c89" - { $as_echo "$as_me:${as_lineno-$LINENO}: result: $ac_cv_prog_cc_c89" >&5 -$as_echo "$ac_cv_prog_cc_c89" >&6; } ;; -esac -if test "x$ac_cv_prog_cc_c89" != xno; then : - -fi - -ac_ext=c -ac_cpp='$CPP $CPPFLAGS' -ac_compile='$CC -c $CFLAGS $CPPFLAGS conftest.$ac_ext >&5' -ac_link='$CC -o conftest$ac_exeext $CFLAGS $CPPFLAGS $LDFLAGS conftest.$ac_ext $LIBS >&5' -ac_compiler_gnu=$ac_cv_c_compiler_gnu - -ac_ext=c -ac_cpp='$CPP $CPPFLAGS' -ac_compile='$CC -c $CFLAGS $CPPFLAGS conftest.$ac_ext >&5' -ac_link='$CC -o conftest$ac_exeext $CFLAGS $CPPFLAGS $LDFLAGS conftest.$ac_ext $LIBS >&5' -ac_compiler_gnu=$ac_cv_c_compiler_gnu -{ $as_echo "$as_me:${as_lineno-$LINENO}: checking whether $CC understands -c and -o together" >&5 -$as_echo_n "checking whether $CC understands -c and -o together... " >&6; } -if ${am_cv_prog_cc_c_o+:} false; then : - $as_echo_n "(cached) " >&6 -else - cat confdefs.h - <<_ACEOF >conftest.$ac_ext -/* end confdefs.h. */ - -int -main () -{ - - ; - return 0; -} -_ACEOF - # Make sure it works both with $CC and with simple cc. - # Following AC_PROG_CC_C_O, we do the test twice because some - # compilers refuse to overwrite an existing .o file with -o, - # though they will create one. - am_cv_prog_cc_c_o=yes - for am_i in 1 2; do - if { echo "$as_me:$LINENO: $CC -c conftest.$ac_ext -o conftest2.$ac_objext" >&5 - ($CC -c conftest.$ac_ext -o conftest2.$ac_objext) >&5 2>&5 - ac_status=$? - echo "$as_me:$LINENO: \$? = $ac_status" >&5 - (exit $ac_status); } \ - && test -f conftest2.$ac_objext; then - : OK - else - am_cv_prog_cc_c_o=no - break - fi - done - rm -f core conftest* - unset am_i -fi -{ $as_echo "$as_me:${as_lineno-$LINENO}: result: $am_cv_prog_cc_c_o" >&5 -$as_echo "$am_cv_prog_cc_c_o" >&6; } -if test "$am_cv_prog_cc_c_o" != yes; then - # Losing compiler, so override with the script. - # FIXME: It is wrong to rewrite CC. - # But if we don't then we get into trouble of one sort or another. - # A longer-term fix would be to have automake use am__CC in this case, - # and then we could set am__CC="\$(top_srcdir)/compile \$(CC)" - CC="$am_aux_dir/compile $CC" -fi -ac_ext=c -ac_cpp='$CPP $CPPFLAGS' -ac_compile='$CC -c $CFLAGS $CPPFLAGS conftest.$ac_ext >&5' -ac_link='$CC -o conftest$ac_exeext $CFLAGS $CPPFLAGS $LDFLAGS conftest.$ac_ext $LIBS >&5' -ac_compiler_gnu=$ac_cv_c_compiler_gnu - -DEPDIR="${am__leading_dot}deps" - -ac_config_commands="$ac_config_commands depfiles" - - -am_make=${MAKE-make} -cat > confinc << 'END' -am__doit: - @echo this is the am__doit target -.PHONY: am__doit -END -# If we don't find an include directive, just comment out the code. -{ $as_echo "$as_me:${as_lineno-$LINENO}: checking for style of include used by $am_make" >&5 -$as_echo_n "checking for style of include used by $am_make... " >&6; } -am__include="#" -am__quote= -_am_result=none -# First try GNU make style include. -echo "include confinc" > confmf -# Ignore all kinds of additional output from 'make'. -case `$am_make -s -f confmf 2> /dev/null` in #( -*the\ am__doit\ target*) - am__include=include - am__quote= - _am_result=GNU - ;; -esac -# Now try BSD make style include. -if test "$am__include" = "#"; then - echo '.include "confinc"' > confmf - case `$am_make -s -f confmf 2> /dev/null` in #( - *the\ am__doit\ target*) - am__include=.include - am__quote="\"" - _am_result=BSD - ;; - esac -fi - - -{ $as_echo "$as_me:${as_lineno-$LINENO}: result: $_am_result" >&5 -$as_echo "$_am_result" >&6; } -rm -f confinc confmf - -@%:@ Check whether --enable-dependency-tracking was given. -if test "${enable_dependency_tracking+set}" = set; then : - enableval=$enable_dependency_tracking; -fi - -if test "x$enable_dependency_tracking" != xno; then - am_depcomp="$ac_aux_dir/depcomp" - AMDEPBACKSLASH='\' - am__nodep='_no' -fi - if test "x$enable_dependency_tracking" != xno; then - AMDEP_TRUE= - AMDEP_FALSE='#' -else - AMDEP_TRUE='#' - AMDEP_FALSE= -fi - - - -depcc="$CC" am_compiler_list= - -{ $as_echo "$as_me:${as_lineno-$LINENO}: checking dependency style of $depcc" >&5 -$as_echo_n "checking dependency style of $depcc... " >&6; } -if ${am_cv_CC_dependencies_compiler_type+:} false; then : - $as_echo_n "(cached) " >&6 -else - if test -z "$AMDEP_TRUE" && test -f "$am_depcomp"; then - # We make a subdir and do the tests there. Otherwise we can end up - # making bogus files that we don't know about and never remove. For - # instance it was reported that on HP-UX the gcc test will end up - # making a dummy file named 'D' -- because '-MD' means "put the output - # in D". - rm -rf conftest.dir - mkdir conftest.dir - # Copy depcomp to subdir because otherwise we won't find it if we're - # using a relative directory. - cp "$am_depcomp" conftest.dir - cd conftest.dir - # We will build objects and dependencies in a subdirectory because - # it helps to detect inapplicable dependency modes. For instance - # both Tru64's cc and ICC support -MD to output dependencies as a - # side effect of compilation, but ICC will put the dependencies in - # the current directory while Tru64 will put them in the object - # directory. - mkdir sub - - am_cv_CC_dependencies_compiler_type=none - if test "$am_compiler_list" = ""; then - am_compiler_list=`sed -n 's/^#*\([a-zA-Z0-9]*\))$/\1/p' < ./depcomp` - fi - am__universal=false - case " $depcc " in #( - *\ -arch\ *\ -arch\ *) am__universal=true ;; - esac - - for depmode in $am_compiler_list; do - # Setup a source with many dependencies, because some compilers - # like to wrap large dependency lists on column 80 (with \), and - # we should not choose a depcomp mode which is confused by this. - # - # We need to recreate these files for each test, as the compiler may - # overwrite some of them when testing with obscure command lines. - # This happens at least with the AIX C compiler. - : > sub/conftest.c - for i in 1 2 3 4 5 6; do - echo '#include "conftst'$i'.h"' >> sub/conftest.c - # Using ": > sub/conftst$i.h" creates only sub/conftst1.h with - # Solaris 10 /bin/sh. - echo '/* dummy */' > sub/conftst$i.h - done - echo "${am__include} ${am__quote}sub/conftest.Po${am__quote}" > confmf - - # We check with '-c' and '-o' for the sake of the "dashmstdout" - # mode. It turns out that the SunPro C++ compiler does not properly - # handle '-M -o', and we need to detect this. Also, some Intel - # versions had trouble with output in subdirs. - am__obj=sub/conftest.${OBJEXT-o} - am__minus_obj="-o $am__obj" - case $depmode in - gcc) - # This depmode causes a compiler race in universal mode. - test "$am__universal" = false || continue - ;; - nosideeffect) - # After this tag, mechanisms are not by side-effect, so they'll - # only be used when explicitly requested. - if test "x$enable_dependency_tracking" = xyes; then - continue - else - break - fi - ;; - msvc7 | msvc7msys | msvisualcpp | msvcmsys) - # This compiler won't grok '-c -o', but also, the minuso test has - # not run yet. These depmodes are late enough in the game, and - # so weak that their functioning should not be impacted. - am__obj=conftest.${OBJEXT-o} - am__minus_obj= - ;; - none) break ;; - esac - if depmode=$depmode \ - source=sub/conftest.c object=$am__obj \ - depfile=sub/conftest.Po tmpdepfile=sub/conftest.TPo \ - $SHELL ./depcomp $depcc -c $am__minus_obj sub/conftest.c \ - >/dev/null 2>conftest.err && - grep sub/conftst1.h sub/conftest.Po > /dev/null 2>&1 && - grep sub/conftst6.h sub/conftest.Po > /dev/null 2>&1 && - grep $am__obj sub/conftest.Po > /dev/null 2>&1 && - ${MAKE-make} -s -f confmf > /dev/null 2>&1; then - # icc doesn't choke on unknown options, it will just issue warnings - # or remarks (even with -Werror). So we grep stderr for any message - # that says an option was ignored or not supported. - # When given -MP, icc 7.0 and 7.1 complain thusly: - # icc: Command line warning: ignoring option '-M'; no argument required - # The diagnosis changed in icc 8.0: - # icc: Command line remark: option '-MP' not supported - if (grep 'ignoring option' conftest.err || - grep 'not supported' conftest.err) >/dev/null 2>&1; then :; else - am_cv_CC_dependencies_compiler_type=$depmode - break - fi - fi - done - - cd .. - rm -rf conftest.dir -else - am_cv_CC_dependencies_compiler_type=none -fi - -fi -{ $as_echo "$as_me:${as_lineno-$LINENO}: result: $am_cv_CC_dependencies_compiler_type" >&5 -$as_echo "$am_cv_CC_dependencies_compiler_type" >&6; } -CCDEPMODE=depmode=$am_cv_CC_dependencies_compiler_type - - if - test "x$enable_dependency_tracking" != xno \ - && test "$am_cv_CC_dependencies_compiler_type" = gcc3; then - am__fastdepCC_TRUE= - am__fastdepCC_FALSE='#' -else - am__fastdepCC_TRUE='#' - am__fastdepCC_FALSE= -fi - - -ac_ext=cpp -ac_cpp='$CXXCPP $CPPFLAGS' -ac_compile='$CXX -c $CXXFLAGS $CPPFLAGS conftest.$ac_ext >&5' -ac_link='$CXX -o conftest$ac_exeext $CXXFLAGS $CPPFLAGS $LDFLAGS conftest.$ac_ext $LIBS >&5' -ac_compiler_gnu=$ac_cv_cxx_compiler_gnu -if test -z "$CXX"; then - if test -n "$CCC"; then - CXX=$CCC - else - if test -n "$ac_tool_prefix"; then - for ac_prog in g++ c++ gpp aCC CC cxx cc++ cl.exe FCC KCC RCC xlC_r xlC - do - # Extract the first word of "$ac_tool_prefix$ac_prog", so it can be a program name with args. -set dummy $ac_tool_prefix$ac_prog; ac_word=$2 -{ $as_echo "$as_me:${as_lineno-$LINENO}: checking for $ac_word" >&5 -$as_echo_n "checking for $ac_word... " >&6; } -if ${ac_cv_prog_CXX+:} false; then : - $as_echo_n "(cached) " >&6 -else - if test -n "$CXX"; then - ac_cv_prog_CXX="$CXX" # Let the user override the test. -else -as_save_IFS=$IFS; IFS=$PATH_SEPARATOR -for as_dir in $PATH -do - IFS=$as_save_IFS - test -z "$as_dir" && as_dir=. - for ac_exec_ext in '' $ac_executable_extensions; do - if as_fn_executable_p "$as_dir/$ac_word$ac_exec_ext"; then - ac_cv_prog_CXX="$ac_tool_prefix$ac_prog" - $as_echo "$as_me:${as_lineno-$LINENO}: found $as_dir/$ac_word$ac_exec_ext" >&5 - break 2 - fi -done - done -IFS=$as_save_IFS - -fi -fi -CXX=$ac_cv_prog_CXX -if test -n "$CXX"; then - { $as_echo "$as_me:${as_lineno-$LINENO}: result: $CXX" >&5 -$as_echo "$CXX" >&6; } -else - { $as_echo "$as_me:${as_lineno-$LINENO}: result: no" >&5 -$as_echo "no" >&6; } -fi - - - test -n "$CXX" && break - done -fi -if test -z "$CXX"; then - ac_ct_CXX=$CXX - for ac_prog in g++ c++ gpp aCC CC cxx cc++ cl.exe FCC KCC RCC xlC_r xlC -do - # Extract the first word of "$ac_prog", so it can be a program name with args. -set dummy $ac_prog; ac_word=$2 -{ $as_echo "$as_me:${as_lineno-$LINENO}: checking for $ac_word" >&5 -$as_echo_n "checking for $ac_word... " >&6; } -if ${ac_cv_prog_ac_ct_CXX+:} false; then : - $as_echo_n "(cached) " >&6 -else - if test -n "$ac_ct_CXX"; then - ac_cv_prog_ac_ct_CXX="$ac_ct_CXX" # Let the user override the test. -else -as_save_IFS=$IFS; IFS=$PATH_SEPARATOR -for as_dir in $PATH -do - IFS=$as_save_IFS - test -z "$as_dir" && as_dir=. - for ac_exec_ext in '' $ac_executable_extensions; do - if as_fn_executable_p "$as_dir/$ac_word$ac_exec_ext"; then - ac_cv_prog_ac_ct_CXX="$ac_prog" - $as_echo "$as_me:${as_lineno-$LINENO}: found $as_dir/$ac_word$ac_exec_ext" >&5 - break 2 - fi -done - done -IFS=$as_save_IFS - -fi -fi -ac_ct_CXX=$ac_cv_prog_ac_ct_CXX -if test -n "$ac_ct_CXX"; then - { $as_echo "$as_me:${as_lineno-$LINENO}: result: $ac_ct_CXX" >&5 -$as_echo "$ac_ct_CXX" >&6; } -else - { $as_echo "$as_me:${as_lineno-$LINENO}: result: no" >&5 -$as_echo "no" >&6; } -fi - - - test -n "$ac_ct_CXX" && break -done - - if test "x$ac_ct_CXX" = x; then - CXX="g++" - else - case $cross_compiling:$ac_tool_warned in -yes:) -{ $as_echo "$as_me:${as_lineno-$LINENO}: WARNING: using cross tools not prefixed with host triplet" >&5 -$as_echo "$as_me: WARNING: using cross tools not prefixed with host triplet" >&2;} -ac_tool_warned=yes ;; -esac - CXX=$ac_ct_CXX - fi -fi - - fi -fi -# Provide some information about the compiler. -$as_echo "$as_me:${as_lineno-$LINENO}: checking for C++ compiler version" >&5 -set X $ac_compile -ac_compiler=$2 -for ac_option in --version -v -V -qversion; do - { { ac_try="$ac_compiler $ac_option >&5" -case "(($ac_try" in - *\"* | *\`* | *\\*) ac_try_echo=\$ac_try;; - *) ac_try_echo=$ac_try;; -esac -eval ac_try_echo="\"\$as_me:${as_lineno-$LINENO}: $ac_try_echo\"" -$as_echo "$ac_try_echo"; } >&5 - (eval "$ac_compiler $ac_option >&5") 2>conftest.err - ac_status=$? - if test -s conftest.err; then - sed '10a\ -... rest of stderr output deleted ... - 10q' conftest.err >conftest.er1 - cat conftest.er1 >&5 - fi - rm -f conftest.er1 conftest.err - $as_echo "$as_me:${as_lineno-$LINENO}: \$? = $ac_status" >&5 - test $ac_status = 0; } -done - -{ $as_echo "$as_me:${as_lineno-$LINENO}: checking whether we are using the GNU C++ compiler" >&5 -$as_echo_n "checking whether we are using the GNU C++ compiler... " >&6; } -if ${ac_cv_cxx_compiler_gnu+:} false; then : - $as_echo_n "(cached) " >&6 -else - cat confdefs.h - <<_ACEOF >conftest.$ac_ext -/* end confdefs.h. */ - -int -main () -{ -#ifndef __GNUC__ - choke me -#endif - - ; - return 0; -} -_ACEOF -if ac_fn_cxx_try_compile "$LINENO"; then : - ac_compiler_gnu=yes -else - ac_compiler_gnu=no -fi -rm -f core conftest.err conftest.$ac_objext conftest.$ac_ext -ac_cv_cxx_compiler_gnu=$ac_compiler_gnu - -fi -{ $as_echo "$as_me:${as_lineno-$LINENO}: result: $ac_cv_cxx_compiler_gnu" >&5 -$as_echo "$ac_cv_cxx_compiler_gnu" >&6; } -if test $ac_compiler_gnu = yes; then - GXX=yes -else - GXX= -fi -ac_test_CXXFLAGS=${CXXFLAGS+set} -ac_save_CXXFLAGS=$CXXFLAGS -{ $as_echo "$as_me:${as_lineno-$LINENO}: checking whether $CXX accepts -g" >&5 -$as_echo_n "checking whether $CXX accepts -g... " >&6; } -if ${ac_cv_prog_cxx_g+:} false; then : - $as_echo_n "(cached) " >&6 -else - ac_save_cxx_werror_flag=$ac_cxx_werror_flag - ac_cxx_werror_flag=yes - ac_cv_prog_cxx_g=no - CXXFLAGS="-g" - cat confdefs.h - <<_ACEOF >conftest.$ac_ext -/* end confdefs.h. */ - -int -main () -{ - - ; - return 0; -} -_ACEOF -if ac_fn_cxx_try_compile "$LINENO"; then : - ac_cv_prog_cxx_g=yes -else - CXXFLAGS="" - cat confdefs.h - <<_ACEOF >conftest.$ac_ext -/* end confdefs.h. */ - -int -main () -{ - - ; - return 0; -} -_ACEOF -if ac_fn_cxx_try_compile "$LINENO"; then : - -else - ac_cxx_werror_flag=$ac_save_cxx_werror_flag - CXXFLAGS="-g" - cat confdefs.h - <<_ACEOF >conftest.$ac_ext -/* end confdefs.h. */ - -int -main () -{ - - ; - return 0; -} -_ACEOF -if ac_fn_cxx_try_compile "$LINENO"; then : - ac_cv_prog_cxx_g=yes -fi -rm -f core conftest.err conftest.$ac_objext conftest.$ac_ext -fi -rm -f core conftest.err conftest.$ac_objext conftest.$ac_ext -fi -rm -f core conftest.err conftest.$ac_objext conftest.$ac_ext - ac_cxx_werror_flag=$ac_save_cxx_werror_flag -fi -{ $as_echo "$as_me:${as_lineno-$LINENO}: result: $ac_cv_prog_cxx_g" >&5 -$as_echo "$ac_cv_prog_cxx_g" >&6; } -if test "$ac_test_CXXFLAGS" = set; then - CXXFLAGS=$ac_save_CXXFLAGS -elif test $ac_cv_prog_cxx_g = yes; then - if test "$GXX" = yes; then - CXXFLAGS="-g -O2" - else - CXXFLAGS="-g" - fi -else - if test "$GXX" = yes; then - CXXFLAGS="-O2" - else - CXXFLAGS= - fi -fi -ac_ext=c -ac_cpp='$CPP $CPPFLAGS' -ac_compile='$CC -c $CFLAGS $CPPFLAGS conftest.$ac_ext >&5' -ac_link='$CC -o conftest$ac_exeext $CFLAGS $CPPFLAGS $LDFLAGS conftest.$ac_ext $LIBS >&5' -ac_compiler_gnu=$ac_cv_c_compiler_gnu - -depcc="$CXX" am_compiler_list= - -{ $as_echo "$as_me:${as_lineno-$LINENO}: checking dependency style of $depcc" >&5 -$as_echo_n "checking dependency style of $depcc... " >&6; } -if ${am_cv_CXX_dependencies_compiler_type+:} false; then : - $as_echo_n "(cached) " >&6 -else - if test -z "$AMDEP_TRUE" && test -f "$am_depcomp"; then - # We make a subdir and do the tests there. Otherwise we can end up - # making bogus files that we don't know about and never remove. For - # instance it was reported that on HP-UX the gcc test will end up - # making a dummy file named 'D' -- because '-MD' means "put the output - # in D". - rm -rf conftest.dir - mkdir conftest.dir - # Copy depcomp to subdir because otherwise we won't find it if we're - # using a relative directory. - cp "$am_depcomp" conftest.dir - cd conftest.dir - # We will build objects and dependencies in a subdirectory because - # it helps to detect inapplicable dependency modes. For instance - # both Tru64's cc and ICC support -MD to output dependencies as a - # side effect of compilation, but ICC will put the dependencies in - # the current directory while Tru64 will put them in the object - # directory. - mkdir sub - - am_cv_CXX_dependencies_compiler_type=none - if test "$am_compiler_list" = ""; then - am_compiler_list=`sed -n 's/^#*\([a-zA-Z0-9]*\))$/\1/p' < ./depcomp` - fi - am__universal=false - case " $depcc " in #( - *\ -arch\ *\ -arch\ *) am__universal=true ;; - esac - - for depmode in $am_compiler_list; do - # Setup a source with many dependencies, because some compilers - # like to wrap large dependency lists on column 80 (with \), and - # we should not choose a depcomp mode which is confused by this. - # - # We need to recreate these files for each test, as the compiler may - # overwrite some of them when testing with obscure command lines. - # This happens at least with the AIX C compiler. - : > sub/conftest.c - for i in 1 2 3 4 5 6; do - echo '#include "conftst'$i'.h"' >> sub/conftest.c - # Using ": > sub/conftst$i.h" creates only sub/conftst1.h with - # Solaris 10 /bin/sh. - echo '/* dummy */' > sub/conftst$i.h - done - echo "${am__include} ${am__quote}sub/conftest.Po${am__quote}" > confmf - - # We check with '-c' and '-o' for the sake of the "dashmstdout" - # mode. It turns out that the SunPro C++ compiler does not properly - # handle '-M -o', and we need to detect this. Also, some Intel - # versions had trouble with output in subdirs. - am__obj=sub/conftest.${OBJEXT-o} - am__minus_obj="-o $am__obj" - case $depmode in - gcc) - # This depmode causes a compiler race in universal mode. - test "$am__universal" = false || continue - ;; - nosideeffect) - # After this tag, mechanisms are not by side-effect, so they'll - # only be used when explicitly requested. - if test "x$enable_dependency_tracking" = xyes; then - continue - else - break - fi - ;; - msvc7 | msvc7msys | msvisualcpp | msvcmsys) - # This compiler won't grok '-c -o', but also, the minuso test has - # not run yet. These depmodes are late enough in the game, and - # so weak that their functioning should not be impacted. - am__obj=conftest.${OBJEXT-o} - am__minus_obj= - ;; - none) break ;; - esac - if depmode=$depmode \ - source=sub/conftest.c object=$am__obj \ - depfile=sub/conftest.Po tmpdepfile=sub/conftest.TPo \ - $SHELL ./depcomp $depcc -c $am__minus_obj sub/conftest.c \ - >/dev/null 2>conftest.err && - grep sub/conftst1.h sub/conftest.Po > /dev/null 2>&1 && - grep sub/conftst6.h sub/conftest.Po > /dev/null 2>&1 && - grep $am__obj sub/conftest.Po > /dev/null 2>&1 && - ${MAKE-make} -s -f confmf > /dev/null 2>&1; then - # icc doesn't choke on unknown options, it will just issue warnings - # or remarks (even with -Werror). So we grep stderr for any message - # that says an option was ignored or not supported. - # When given -MP, icc 7.0 and 7.1 complain thusly: - # icc: Command line warning: ignoring option '-M'; no argument required - # The diagnosis changed in icc 8.0: - # icc: Command line remark: option '-MP' not supported - if (grep 'ignoring option' conftest.err || - grep 'not supported' conftest.err) >/dev/null 2>&1; then :; else - am_cv_CXX_dependencies_compiler_type=$depmode - break - fi - fi - done - - cd .. - rm -rf conftest.dir -else - am_cv_CXX_dependencies_compiler_type=none -fi - -fi -{ $as_echo "$as_me:${as_lineno-$LINENO}: result: $am_cv_CXX_dependencies_compiler_type" >&5 -$as_echo "$am_cv_CXX_dependencies_compiler_type" >&6; } -CXXDEPMODE=depmode=$am_cv_CXX_dependencies_compiler_type - - if - test "x$enable_dependency_tracking" != xno \ - && test "$am_cv_CXX_dependencies_compiler_type" = gcc3; then - am__fastdepCXX_TRUE= - am__fastdepCXX_FALSE='#' -else - am__fastdepCXX_TRUE='#' - am__fastdepCXX_FALSE= -fi - - -ac_ext=c -ac_cpp='$CPP $CPPFLAGS' -ac_compile='$CC -c $CFLAGS $CPPFLAGS conftest.$ac_ext >&5' -ac_link='$CC -o conftest$ac_exeext $CFLAGS $CPPFLAGS $LDFLAGS conftest.$ac_ext $LIBS >&5' -ac_compiler_gnu=$ac_cv_c_compiler_gnu -{ $as_echo "$as_me:${as_lineno-$LINENO}: checking how to run the C preprocessor" >&5 -$as_echo_n "checking how to run the C preprocessor... " >&6; } -# On Suns, sometimes $CPP names a directory. -if test -n "$CPP" && test -d "$CPP"; then - CPP= -fi -if test -z "$CPP"; then - if ${ac_cv_prog_CPP+:} false; then : - $as_echo_n "(cached) " >&6 -else - # Double quotes because CPP needs to be expanded - for CPP in "$CC -E" "$CC -E -traditional-cpp" "/lib/cpp" - do - ac_preproc_ok=false -for ac_c_preproc_warn_flag in '' yes -do - # Use a header file that comes with gcc, so configuring glibc - # with a fresh cross-compiler works. - # Prefer to if __STDC__ is defined, since - # exists even on freestanding compilers. - # On the NeXT, cc -E runs the code through the compiler's parser, - # not just through cpp. "Syntax error" is here to catch this case. - cat confdefs.h - <<_ACEOF >conftest.$ac_ext -/* end confdefs.h. */ -@%:@ifdef __STDC__ -@%:@ include -@%:@else -@%:@ include -@%:@endif - Syntax error -_ACEOF -if ac_fn_c_try_cpp "$LINENO"; then : - -else - # Broken: fails on valid input. -continue -fi -rm -f conftest.err conftest.i conftest.$ac_ext - - # OK, works on sane cases. Now check whether nonexistent headers - # can be detected and how. - cat confdefs.h - <<_ACEOF >conftest.$ac_ext -/* end confdefs.h. */ -@%:@include -_ACEOF -if ac_fn_c_try_cpp "$LINENO"; then : - # Broken: success on invalid input. -continue -else - # Passes both tests. -ac_preproc_ok=: -break -fi -rm -f conftest.err conftest.i conftest.$ac_ext - -done -# Because of `break', _AC_PREPROC_IFELSE's cleaning code was skipped. -rm -f conftest.i conftest.err conftest.$ac_ext -if $ac_preproc_ok; then : - break -fi - - done - ac_cv_prog_CPP=$CPP - -fi - CPP=$ac_cv_prog_CPP -else - ac_cv_prog_CPP=$CPP -fi -{ $as_echo "$as_me:${as_lineno-$LINENO}: result: $CPP" >&5 -$as_echo "$CPP" >&6; } -ac_preproc_ok=false -for ac_c_preproc_warn_flag in '' yes -do - # Use a header file that comes with gcc, so configuring glibc - # with a fresh cross-compiler works. - # Prefer to if __STDC__ is defined, since - # exists even on freestanding compilers. - # On the NeXT, cc -E runs the code through the compiler's parser, - # not just through cpp. "Syntax error" is here to catch this case. - cat confdefs.h - <<_ACEOF >conftest.$ac_ext -/* end confdefs.h. */ -@%:@ifdef __STDC__ -@%:@ include -@%:@else -@%:@ include -@%:@endif - Syntax error -_ACEOF -if ac_fn_c_try_cpp "$LINENO"; then : - -else - # Broken: fails on valid input. -continue -fi -rm -f conftest.err conftest.i conftest.$ac_ext - - # OK, works on sane cases. Now check whether nonexistent headers - # can be detected and how. - cat confdefs.h - <<_ACEOF >conftest.$ac_ext -/* end confdefs.h. */ -@%:@include -_ACEOF -if ac_fn_c_try_cpp "$LINENO"; then : - # Broken: success on invalid input. -continue -else - # Passes both tests. -ac_preproc_ok=: -break -fi -rm -f conftest.err conftest.i conftest.$ac_ext - -done -# Because of `break', _AC_PREPROC_IFELSE's cleaning code was skipped. -rm -f conftest.i conftest.err conftest.$ac_ext -if $ac_preproc_ok; then : - -else - { { $as_echo "$as_me:${as_lineno-$LINENO}: error: in \`$ac_pwd':" >&5 -$as_echo "$as_me: error: in \`$ac_pwd':" >&2;} -as_fn_error $? "C preprocessor \"$CPP\" fails sanity check -See \`config.log' for more details" "$LINENO" 5; } -fi - -ac_ext=c -ac_cpp='$CPP $CPPFLAGS' -ac_compile='$CC -c $CFLAGS $CPPFLAGS conftest.$ac_ext >&5' -ac_link='$CC -o conftest$ac_exeext $CFLAGS $CPPFLAGS $LDFLAGS conftest.$ac_ext $LIBS >&5' -ac_compiler_gnu=$ac_cv_c_compiler_gnu - -ac_ext=${ac_fc_srcext-f} -ac_compile='$FC -c $FCFLAGS $ac_fcflags_srcext conftest.$ac_ext >&5' -ac_link='$FC -o conftest$ac_exeext $FCFLAGS $LDFLAGS $ac_fcflags_srcext conftest.$ac_ext $LIBS >&5' -ac_compiler_gnu=$ac_cv_fc_compiler_gnu -if test -n "$ac_tool_prefix"; then - for ac_prog in gfortran g95 xlf95 f95 fort ifort ifc efc pgfortran pgf95 lf95 ftn nagfor xlf90 f90 pgf90 pghpf epcf90 g77 xlf f77 frt pgf77 cf77 fort77 fl32 af77 - do - # Extract the first word of "$ac_tool_prefix$ac_prog", so it can be a program name with args. -set dummy $ac_tool_prefix$ac_prog; ac_word=$2 -{ $as_echo "$as_me:${as_lineno-$LINENO}: checking for $ac_word" >&5 -$as_echo_n "checking for $ac_word... " >&6; } -if ${ac_cv_prog_FC+:} false; then : - $as_echo_n "(cached) " >&6 -else - if test -n "$FC"; then - ac_cv_prog_FC="$FC" # Let the user override the test. -else -as_save_IFS=$IFS; IFS=$PATH_SEPARATOR -for as_dir in $PATH -do - IFS=$as_save_IFS - test -z "$as_dir" && as_dir=. - for ac_exec_ext in '' $ac_executable_extensions; do - if as_fn_executable_p "$as_dir/$ac_word$ac_exec_ext"; then - ac_cv_prog_FC="$ac_tool_prefix$ac_prog" - $as_echo "$as_me:${as_lineno-$LINENO}: found $as_dir/$ac_word$ac_exec_ext" >&5 - break 2 - fi -done - done -IFS=$as_save_IFS - -fi -fi -FC=$ac_cv_prog_FC -if test -n "$FC"; then - { $as_echo "$as_me:${as_lineno-$LINENO}: result: $FC" >&5 -$as_echo "$FC" >&6; } -else - { $as_echo "$as_me:${as_lineno-$LINENO}: result: no" >&5 -$as_echo "no" >&6; } -fi - - - test -n "$FC" && break - done -fi -if test -z "$FC"; then - ac_ct_FC=$FC - for ac_prog in gfortran g95 xlf95 f95 fort ifort ifc efc pgfortran pgf95 lf95 ftn nagfor xlf90 f90 pgf90 pghpf epcf90 g77 xlf f77 frt pgf77 cf77 fort77 fl32 af77 -do - # Extract the first word of "$ac_prog", so it can be a program name with args. -set dummy $ac_prog; ac_word=$2 -{ $as_echo "$as_me:${as_lineno-$LINENO}: checking for $ac_word" >&5 -$as_echo_n "checking for $ac_word... " >&6; } -if ${ac_cv_prog_ac_ct_FC+:} false; then : - $as_echo_n "(cached) " >&6 -else - if test -n "$ac_ct_FC"; then - ac_cv_prog_ac_ct_FC="$ac_ct_FC" # Let the user override the test. -else -as_save_IFS=$IFS; IFS=$PATH_SEPARATOR -for as_dir in $PATH -do - IFS=$as_save_IFS - test -z "$as_dir" && as_dir=. - for ac_exec_ext in '' $ac_executable_extensions; do - if as_fn_executable_p "$as_dir/$ac_word$ac_exec_ext"; then - ac_cv_prog_ac_ct_FC="$ac_prog" - $as_echo "$as_me:${as_lineno-$LINENO}: found $as_dir/$ac_word$ac_exec_ext" >&5 - break 2 - fi -done - done -IFS=$as_save_IFS - -fi -fi -ac_ct_FC=$ac_cv_prog_ac_ct_FC -if test -n "$ac_ct_FC"; then - { $as_echo "$as_me:${as_lineno-$LINENO}: result: $ac_ct_FC" >&5 -$as_echo "$ac_ct_FC" >&6; } -else - { $as_echo "$as_me:${as_lineno-$LINENO}: result: no" >&5 -$as_echo "no" >&6; } -fi - - - test -n "$ac_ct_FC" && break -done - - if test "x$ac_ct_FC" = x; then - FC="" - else - case $cross_compiling:$ac_tool_warned in -yes:) -{ $as_echo "$as_me:${as_lineno-$LINENO}: WARNING: using cross tools not prefixed with host triplet" >&5 -$as_echo "$as_me: WARNING: using cross tools not prefixed with host triplet" >&2;} -ac_tool_warned=yes ;; -esac - FC=$ac_ct_FC - fi -fi - - -# Provide some information about the compiler. -$as_echo "$as_me:${as_lineno-$LINENO}: checking for Fortran compiler version" >&5 -set X $ac_compile -ac_compiler=$2 -for ac_option in --version -v -V -qversion; do - { { ac_try="$ac_compiler $ac_option >&5" -case "(($ac_try" in - *\"* | *\`* | *\\*) ac_try_echo=\$ac_try;; - *) ac_try_echo=$ac_try;; -esac -eval ac_try_echo="\"\$as_me:${as_lineno-$LINENO}: $ac_try_echo\"" -$as_echo "$ac_try_echo"; } >&5 - (eval "$ac_compiler $ac_option >&5") 2>conftest.err - ac_status=$? - if test -s conftest.err; then - sed '10a\ -... rest of stderr output deleted ... - 10q' conftest.err >conftest.er1 - cat conftest.er1 >&5 - fi - rm -f conftest.er1 conftest.err - $as_echo "$as_me:${as_lineno-$LINENO}: \$? = $ac_status" >&5 - test $ac_status = 0; } -done -rm -f a.out - -# If we don't use `.F' as extension, the preprocessor is not run on the -# input file. (Note that this only needs to work for GNU compilers.) -ac_save_ext=$ac_ext -ac_ext=F -{ $as_echo "$as_me:${as_lineno-$LINENO}: checking whether we are using the GNU Fortran compiler" >&5 -$as_echo_n "checking whether we are using the GNU Fortran compiler... " >&6; } -if ${ac_cv_fc_compiler_gnu+:} false; then : - $as_echo_n "(cached) " >&6 -else - cat > conftest.$ac_ext <<_ACEOF - program main -#ifndef __GNUC__ - choke me -#endif - - end -_ACEOF -if ac_fn_fc_try_compile "$LINENO"; then : - ac_compiler_gnu=yes -else - ac_compiler_gnu=no -fi -rm -f core conftest.err conftest.$ac_objext conftest.$ac_ext -ac_cv_fc_compiler_gnu=$ac_compiler_gnu - -fi -{ $as_echo "$as_me:${as_lineno-$LINENO}: result: $ac_cv_fc_compiler_gnu" >&5 -$as_echo "$ac_cv_fc_compiler_gnu" >&6; } -ac_ext=$ac_save_ext -ac_test_FCFLAGS=${FCFLAGS+set} -ac_save_FCFLAGS=$FCFLAGS -FCFLAGS= -{ $as_echo "$as_me:${as_lineno-$LINENO}: checking whether $FC accepts -g" >&5 -$as_echo_n "checking whether $FC accepts -g... " >&6; } -if ${ac_cv_prog_fc_g+:} false; then : - $as_echo_n "(cached) " >&6 -else - FCFLAGS=-g -cat > conftest.$ac_ext <<_ACEOF - program main - - end -_ACEOF -if ac_fn_fc_try_compile "$LINENO"; then : - ac_cv_prog_fc_g=yes -else - ac_cv_prog_fc_g=no -fi -rm -f core conftest.err conftest.$ac_objext conftest.$ac_ext - -fi -{ $as_echo "$as_me:${as_lineno-$LINENO}: result: $ac_cv_prog_fc_g" >&5 -$as_echo "$ac_cv_prog_fc_g" >&6; } -if test "$ac_test_FCFLAGS" = set; then - FCFLAGS=$ac_save_FCFLAGS -elif test $ac_cv_prog_fc_g = yes; then - if test "x$ac_cv_fc_compiler_gnu" = xyes; then - FCFLAGS="-g -O2" - else - FCFLAGS="-g" - fi -else - if test "x$ac_cv_fc_compiler_gnu" = xyes; then - FCFLAGS="-O2" - else - FCFLAGS= - fi -fi - -if test $ac_compiler_gnu = yes; then - GFC=yes -else - GFC= -fi -ac_ext=c -ac_cpp='$CPP $CPPFLAGS' -ac_compile='$CC -c $CFLAGS $CPPFLAGS conftest.$ac_ext >&5' -ac_link='$CC -o conftest$ac_exeext $CFLAGS $CPPFLAGS $LDFLAGS conftest.$ac_ext $LIBS >&5' -ac_compiler_gnu=$ac_cv_c_compiler_gnu - -if test -n "$ac_tool_prefix"; then - # Extract the first word of "${ac_tool_prefix}ranlib", so it can be a program name with args. -set dummy ${ac_tool_prefix}ranlib; ac_word=$2 -{ $as_echo "$as_me:${as_lineno-$LINENO}: checking for $ac_word" >&5 -$as_echo_n "checking for $ac_word... " >&6; } -if ${ac_cv_prog_RANLIB+:} false; then : - $as_echo_n "(cached) " >&6 -else - if test -n "$RANLIB"; then - ac_cv_prog_RANLIB="$RANLIB" # Let the user override the test. -else -as_save_IFS=$IFS; IFS=$PATH_SEPARATOR -for as_dir in $PATH -do - IFS=$as_save_IFS - test -z "$as_dir" && as_dir=. - for ac_exec_ext in '' $ac_executable_extensions; do - if as_fn_executable_p "$as_dir/$ac_word$ac_exec_ext"; then - ac_cv_prog_RANLIB="${ac_tool_prefix}ranlib" - $as_echo "$as_me:${as_lineno-$LINENO}: found $as_dir/$ac_word$ac_exec_ext" >&5 - break 2 - fi -done - done -IFS=$as_save_IFS - -fi -fi -RANLIB=$ac_cv_prog_RANLIB -if test -n "$RANLIB"; then - { $as_echo "$as_me:${as_lineno-$LINENO}: result: $RANLIB" >&5 -$as_echo "$RANLIB" >&6; } -else - { $as_echo "$as_me:${as_lineno-$LINENO}: result: no" >&5 -$as_echo "no" >&6; } -fi - - -fi -if test -z "$ac_cv_prog_RANLIB"; then - ac_ct_RANLIB=$RANLIB - # Extract the first word of "ranlib", so it can be a program name with args. -set dummy ranlib; ac_word=$2 -{ $as_echo "$as_me:${as_lineno-$LINENO}: checking for $ac_word" >&5 -$as_echo_n "checking for $ac_word... " >&6; } -if ${ac_cv_prog_ac_ct_RANLIB+:} false; then : - $as_echo_n "(cached) " >&6 -else - if test -n "$ac_ct_RANLIB"; then - ac_cv_prog_ac_ct_RANLIB="$ac_ct_RANLIB" # Let the user override the test. -else -as_save_IFS=$IFS; IFS=$PATH_SEPARATOR -for as_dir in $PATH -do - IFS=$as_save_IFS - test -z "$as_dir" && as_dir=. - for ac_exec_ext in '' $ac_executable_extensions; do - if as_fn_executable_p "$as_dir/$ac_word$ac_exec_ext"; then - ac_cv_prog_ac_ct_RANLIB="ranlib" - $as_echo "$as_me:${as_lineno-$LINENO}: found $as_dir/$ac_word$ac_exec_ext" >&5 - break 2 - fi -done - done -IFS=$as_save_IFS - -fi -fi -ac_ct_RANLIB=$ac_cv_prog_ac_ct_RANLIB -if test -n "$ac_ct_RANLIB"; then - { $as_echo "$as_me:${as_lineno-$LINENO}: result: $ac_ct_RANLIB" >&5 -$as_echo "$ac_ct_RANLIB" >&6; } -else - { $as_echo "$as_me:${as_lineno-$LINENO}: result: no" >&5 -$as_echo "no" >&6; } -fi - - if test "x$ac_ct_RANLIB" = x; then - RANLIB=":" - else - case $cross_compiling:$ac_tool_warned in -yes:) -{ $as_echo "$as_me:${as_lineno-$LINENO}: WARNING: using cross tools not prefixed with host triplet" >&5 -$as_echo "$as_me: WARNING: using cross tools not prefixed with host triplet" >&2;} -ac_tool_warned=yes ;; -esac - RANLIB=$ac_ct_RANLIB - fi -else - RANLIB="$ac_cv_prog_RANLIB" -fi - - -{ $as_echo "$as_me:${as_lineno-$LINENO}: checking whether ln -s works" >&5 -$as_echo_n "checking whether ln -s works... " >&6; } -LN_S=$as_ln_s -if test "$LN_S" = "ln -s"; then - { $as_echo "$as_me:${as_lineno-$LINENO}: result: yes" >&5 -$as_echo "yes" >&6; } -else - { $as_echo "$as_me:${as_lineno-$LINENO}: result: no, using $LN_S" >&5 -$as_echo "no, using $LN_S" >&6; } -fi - -{ $as_echo "$as_me:${as_lineno-$LINENO}: checking whether ${MAKE-make} sets \$(MAKE)" >&5 -$as_echo_n "checking whether ${MAKE-make} sets \$(MAKE)... " >&6; } -set x ${MAKE-make} -ac_make=`$as_echo "$2" | sed 's/+/p/g; s/[^a-zA-Z0-9_]/_/g'` -if eval \${ac_cv_prog_make_${ac_make}_set+:} false; then : - $as_echo_n "(cached) " >&6 -else - cat >conftest.make <<\_ACEOF -SHELL = /bin/sh -all: - @echo '@@@%%%=$(MAKE)=@@@%%%' -_ACEOF -# GNU make sometimes prints "make[1]: Entering ...", which would confuse us. -case `${MAKE-make} -f conftest.make 2>/dev/null` in - *@@@%%%=?*=@@@%%%*) - eval ac_cv_prog_make_${ac_make}_set=yes;; - *) - eval ac_cv_prog_make_${ac_make}_set=no;; -esac -rm -f conftest.make -fi -if eval test \$ac_cv_prog_make_${ac_make}_set = yes; then - { $as_echo "$as_me:${as_lineno-$LINENO}: result: yes" >&5 -$as_echo "yes" >&6; } - SET_MAKE= -else - { $as_echo "$as_me:${as_lineno-$LINENO}: result: no" >&5 -$as_echo "no" >&6; } - SET_MAKE="MAKE=${MAKE-make}" -fi - - - - -{ $as_echo "$as_me:${as_lineno-$LINENO}: checking for grep that handles long lines and -e" >&5 -$as_echo_n "checking for grep that handles long lines and -e... " >&6; } -if ${ac_cv_path_GREP+:} false; then : - $as_echo_n "(cached) " >&6 -else - if test -z "$GREP"; then - ac_path_GREP_found=false - # Loop through the user's path and test for each of PROGNAME-LIST - as_save_IFS=$IFS; IFS=$PATH_SEPARATOR -for as_dir in $PATH$PATH_SEPARATOR/usr/xpg4/bin -do - IFS=$as_save_IFS - test -z "$as_dir" && as_dir=. - for ac_prog in grep ggrep; do - for ac_exec_ext in '' $ac_executable_extensions; do - ac_path_GREP="$as_dir/$ac_prog$ac_exec_ext" - as_fn_executable_p "$ac_path_GREP" || continue -# Check for GNU ac_path_GREP and select it if it is found. - # Check for GNU $ac_path_GREP -case `"$ac_path_GREP" --version 2>&1` in -*GNU*) - ac_cv_path_GREP="$ac_path_GREP" ac_path_GREP_found=:;; -*) - ac_count=0 - $as_echo_n 0123456789 >"conftest.in" - while : - do - cat "conftest.in" "conftest.in" >"conftest.tmp" - mv "conftest.tmp" "conftest.in" - cp "conftest.in" "conftest.nl" - $as_echo 'GREP' >> "conftest.nl" - "$ac_path_GREP" -e 'GREP$' -e '-(cannot match)-' < "conftest.nl" >"conftest.out" 2>/dev/null || break - diff "conftest.out" "conftest.nl" >/dev/null 2>&1 || break - as_fn_arith $ac_count + 1 && ac_count=$as_val - if test $ac_count -gt ${ac_path_GREP_max-0}; then - # Best one so far, save it but keep looking for a better one - ac_cv_path_GREP="$ac_path_GREP" - ac_path_GREP_max=$ac_count - fi - # 10*(2^10) chars as input seems more than enough - test $ac_count -gt 10 && break - done - rm -f conftest.in conftest.tmp conftest.nl conftest.out;; -esac - - $ac_path_GREP_found && break 3 - done - done - done -IFS=$as_save_IFS - if test -z "$ac_cv_path_GREP"; then - as_fn_error $? "no acceptable grep could be found in $PATH$PATH_SEPARATOR/usr/xpg4/bin" "$LINENO" 5 - fi -else - ac_cv_path_GREP=$GREP -fi - -fi -{ $as_echo "$as_me:${as_lineno-$LINENO}: result: $ac_cv_path_GREP" >&5 -$as_echo "$ac_cv_path_GREP" >&6; } - GREP="$ac_cv_path_GREP" - - -{ $as_echo "$as_me:${as_lineno-$LINENO}: checking for egrep" >&5 -$as_echo_n "checking for egrep... " >&6; } -if ${ac_cv_path_EGREP+:} false; then : - $as_echo_n "(cached) " >&6 -else - if echo a | $GREP -E '(a|b)' >/dev/null 2>&1 - then ac_cv_path_EGREP="$GREP -E" - else - if test -z "$EGREP"; then - ac_path_EGREP_found=false - # Loop through the user's path and test for each of PROGNAME-LIST - as_save_IFS=$IFS; IFS=$PATH_SEPARATOR -for as_dir in $PATH$PATH_SEPARATOR/usr/xpg4/bin -do - IFS=$as_save_IFS - test -z "$as_dir" && as_dir=. - for ac_prog in egrep; do - for ac_exec_ext in '' $ac_executable_extensions; do - ac_path_EGREP="$as_dir/$ac_prog$ac_exec_ext" - as_fn_executable_p "$ac_path_EGREP" || continue -# Check for GNU ac_path_EGREP and select it if it is found. - # Check for GNU $ac_path_EGREP -case `"$ac_path_EGREP" --version 2>&1` in -*GNU*) - ac_cv_path_EGREP="$ac_path_EGREP" ac_path_EGREP_found=:;; -*) - ac_count=0 - $as_echo_n 0123456789 >"conftest.in" - while : - do - cat "conftest.in" "conftest.in" >"conftest.tmp" - mv "conftest.tmp" "conftest.in" - cp "conftest.in" "conftest.nl" - $as_echo 'EGREP' >> "conftest.nl" - "$ac_path_EGREP" 'EGREP$' < "conftest.nl" >"conftest.out" 2>/dev/null || break - diff "conftest.out" "conftest.nl" >/dev/null 2>&1 || break - as_fn_arith $ac_count + 1 && ac_count=$as_val - if test $ac_count -gt ${ac_path_EGREP_max-0}; then - # Best one so far, save it but keep looking for a better one - ac_cv_path_EGREP="$ac_path_EGREP" - ac_path_EGREP_max=$ac_count - fi - # 10*(2^10) chars as input seems more than enough - test $ac_count -gt 10 && break - done - rm -f conftest.in conftest.tmp conftest.nl conftest.out;; -esac - - $ac_path_EGREP_found && break 3 - done - done - done -IFS=$as_save_IFS - if test -z "$ac_cv_path_EGREP"; then - as_fn_error $? "no acceptable egrep could be found in $PATH$PATH_SEPARATOR/usr/xpg4/bin" "$LINENO" 5 - fi -else - ac_cv_path_EGREP=$EGREP -fi - - fi -fi -{ $as_echo "$as_me:${as_lineno-$LINENO}: result: $ac_cv_path_EGREP" >&5 -$as_echo "$ac_cv_path_EGREP" >&6; } - EGREP="$ac_cv_path_EGREP" - - -{ $as_echo "$as_me:${as_lineno-$LINENO}: checking for ANSI C header files" >&5 -$as_echo_n "checking for ANSI C header files... " >&6; } -if ${ac_cv_header_stdc+:} false; then : - $as_echo_n "(cached) " >&6 -else - cat confdefs.h - <<_ACEOF >conftest.$ac_ext -/* end confdefs.h. */ -#include -#include -#include -#include - -int -main () -{ - - ; - return 0; -} -_ACEOF -if ac_fn_c_try_compile "$LINENO"; then : - ac_cv_header_stdc=yes -else - ac_cv_header_stdc=no -fi -rm -f core conftest.err conftest.$ac_objext conftest.$ac_ext - -if test $ac_cv_header_stdc = yes; then - # SunOS 4.x string.h does not declare mem*, contrary to ANSI. - cat confdefs.h - <<_ACEOF >conftest.$ac_ext -/* end confdefs.h. */ -#include - -_ACEOF -if (eval "$ac_cpp conftest.$ac_ext") 2>&5 | - $EGREP "memchr" >/dev/null 2>&1; then : - -else - ac_cv_header_stdc=no -fi -rm -f conftest* - -fi - -if test $ac_cv_header_stdc = yes; then - # ISC 2.0.2 stdlib.h does not declare free, contrary to ANSI. - cat confdefs.h - <<_ACEOF >conftest.$ac_ext -/* end confdefs.h. */ -#include - -_ACEOF -if (eval "$ac_cpp conftest.$ac_ext") 2>&5 | - $EGREP "free" >/dev/null 2>&1; then : - -else - ac_cv_header_stdc=no -fi -rm -f conftest* - -fi - -if test $ac_cv_header_stdc = yes; then - # /bin/cc in Irix-4.0.5 gets non-ANSI ctype macros unless using -ansi. - if test "$cross_compiling" = yes; then : - : -else - cat confdefs.h - <<_ACEOF >conftest.$ac_ext -/* end confdefs.h. */ -#include -#include -#if ((' ' & 0x0FF) == 0x020) -# define ISLOWER(c) ('a' <= (c) && (c) <= 'z') -# define TOUPPER(c) (ISLOWER(c) ? 'A' + ((c) - 'a') : (c)) -#else -# define ISLOWER(c) \ - (('a' <= (c) && (c) <= 'i') \ - || ('j' <= (c) && (c) <= 'r') \ - || ('s' <= (c) && (c) <= 'z')) -# define TOUPPER(c) (ISLOWER(c) ? ((c) | 0x40) : (c)) -#endif - -#define XOR(e, f) (((e) && !(f)) || (!(e) && (f))) -int -main () -{ - int i; - for (i = 0; i < 256; i++) - if (XOR (islower (i), ISLOWER (i)) - || toupper (i) != TOUPPER (i)) - return 2; - return 0; -} -_ACEOF -if ac_fn_c_try_run "$LINENO"; then : - -else - ac_cv_header_stdc=no -fi -rm -f core *.core core.conftest.* gmon.out bb.out conftest$ac_exeext \ - conftest.$ac_objext conftest.beam conftest.$ac_ext -fi - -fi -fi -{ $as_echo "$as_me:${as_lineno-$LINENO}: result: $ac_cv_header_stdc" >&5 -$as_echo "$ac_cv_header_stdc" >&6; } -if test $ac_cv_header_stdc = yes; then - -$as_echo "@%:@define STDC_HEADERS 1" >>confdefs.h - -fi - - -# On IRIX 5.3, sys/types and inttypes.h are conflicting. -for ac_header in sys/types.h sys/stat.h stdlib.h string.h memory.h strings.h \ - inttypes.h stdint.h unistd.h -do : - as_ac_Header=`$as_echo "ac_cv_header_$ac_header" | $as_tr_sh` -ac_fn_c_check_header_compile "$LINENO" "$ac_header" "$as_ac_Header" "$ac_includes_default -" -if eval test \"x\$"$as_ac_Header"\" = x"yes"; then : - cat >>confdefs.h <<_ACEOF -@%:@define `$as_echo "HAVE_$ac_header" | $as_tr_cpp` 1 -_ACEOF - -fi - -done - - -ac_fn_c_check_type "$LINENO" "size_t" "ac_cv_type_size_t" "$ac_includes_default" -if test "x$ac_cv_type_size_t" = xyes; then : - -else - -cat >>confdefs.h <<_ACEOF -@%:@define size_t unsigned int -_ACEOF - -fi - -{ $as_echo "$as_me:${as_lineno-$LINENO}: checking whether struct tm is in sys/time.h or time.h" >&5 -$as_echo_n "checking whether struct tm is in sys/time.h or time.h... " >&6; } -if ${ac_cv_struct_tm+:} false; then : - $as_echo_n "(cached) " >&6 -else - cat confdefs.h - <<_ACEOF >conftest.$ac_ext -/* end confdefs.h. */ -#include -#include - -int -main () -{ -struct tm tm; - int *p = &tm.tm_sec; - return !p; - ; - return 0; -} -_ACEOF -if ac_fn_c_try_compile "$LINENO"; then : - ac_cv_struct_tm=time.h -else - ac_cv_struct_tm=sys/time.h -fi -rm -f core conftest.err conftest.$ac_objext conftest.$ac_ext -fi -{ $as_echo "$as_me:${as_lineno-$LINENO}: result: $ac_cv_struct_tm" >&5 -$as_echo "$ac_cv_struct_tm" >&6; } -if test $ac_cv_struct_tm = sys/time.h; then - -$as_echo "@%:@define TM_IN_SYS_TIME 1" >>confdefs.h - -fi - -{ $as_echo "$as_me:${as_lineno-$LINENO}: checking for an ANSI C-conforming const" >&5 -$as_echo_n "checking for an ANSI C-conforming const... " >&6; } -if ${ac_cv_c_const+:} false; then : - $as_echo_n "(cached) " >&6 -else - cat confdefs.h - <<_ACEOF >conftest.$ac_ext -/* end confdefs.h. */ - -int -main () -{ - -#ifndef __cplusplus - /* Ultrix mips cc rejects this sort of thing. */ - typedef int charset[2]; - const charset cs = { 0, 0 }; - /* SunOS 4.1.1 cc rejects this. */ - char const *const *pcpcc; - char **ppc; - /* NEC SVR4.0.2 mips cc rejects this. */ - struct point {int x, y;}; - static struct point const zero = {0,0}; - /* AIX XL C 1.02.0.0 rejects this. - It does not let you subtract one const X* pointer from another in - an arm of an if-expression whose if-part is not a constant - expression */ - const char *g = "string"; - pcpcc = &g + (g ? g-g : 0); - /* HPUX 7.0 cc rejects these. */ - ++pcpcc; - ppc = (char**) pcpcc; - pcpcc = (char const *const *) ppc; - { /* SCO 3.2v4 cc rejects this sort of thing. */ - char tx; - char *t = &tx; - char const *s = 0 ? (char *) 0 : (char const *) 0; - - *t++ = 0; - if (s) return 0; - } - { /* Someone thinks the Sun supposedly-ANSI compiler will reject this. */ - int x[] = {25, 17}; - const int *foo = &x[0]; - ++foo; - } - { /* Sun SC1.0 ANSI compiler rejects this -- but not the above. */ - typedef const int *iptr; - iptr p = 0; - ++p; - } - { /* AIX XL C 1.02.0.0 rejects this sort of thing, saying - "k.c", line 2.27: 1506-025 (S) Operand must be a modifiable lvalue. */ - struct s { int j; const int *ap[3]; } bx; - struct s *b = &bx; b->j = 5; - } - { /* ULTRIX-32 V3.1 (Rev 9) vcc rejects this */ - const int foo = 10; - if (!foo) return 0; - } - return !cs[0] && !zero.x; -#endif - - ; - return 0; -} -_ACEOF -if ac_fn_c_try_compile "$LINENO"; then : - ac_cv_c_const=yes -else - ac_cv_c_const=no -fi -rm -f core conftest.err conftest.$ac_objext conftest.$ac_ext -fi -{ $as_echo "$as_me:${as_lineno-$LINENO}: result: $ac_cv_c_const" >&5 -$as_echo "$ac_cv_c_const" >&6; } -if test $ac_cv_c_const = no; then - -$as_echo "@%:@define const /**/" >>confdefs.h - -fi - -for ac_header in stdlib.h -do : - ac_fn_c_check_header_mongrel "$LINENO" "stdlib.h" "ac_cv_header_stdlib_h" "$ac_includes_default" -if test "x$ac_cv_header_stdlib_h" = xyes; then : - cat >>confdefs.h <<_ACEOF -@%:@define HAVE_STDLIB_H 1 -_ACEOF - -fi - -done - -{ $as_echo "$as_me:${as_lineno-$LINENO}: checking for GNU libc compatible malloc" >&5 -$as_echo_n "checking for GNU libc compatible malloc... " >&6; } -if ${ac_cv_func_malloc_0_nonnull+:} false; then : - $as_echo_n "(cached) " >&6 -else - if test "$cross_compiling" = yes; then : - ac_cv_func_malloc_0_nonnull=no -else - cat confdefs.h - <<_ACEOF >conftest.$ac_ext -/* end confdefs.h. */ -#if defined STDC_HEADERS || defined HAVE_STDLIB_H -# include -#else -char *malloc (); -#endif - -int -main () -{ -return ! malloc (0); - ; - return 0; -} -_ACEOF -if ac_fn_c_try_run "$LINENO"; then : - ac_cv_func_malloc_0_nonnull=yes -else - ac_cv_func_malloc_0_nonnull=no -fi -rm -f core *.core core.conftest.* gmon.out bb.out conftest$ac_exeext \ - conftest.$ac_objext conftest.beam conftest.$ac_ext -fi - -fi -{ $as_echo "$as_me:${as_lineno-$LINENO}: result: $ac_cv_func_malloc_0_nonnull" >&5 -$as_echo "$ac_cv_func_malloc_0_nonnull" >&6; } -if test $ac_cv_func_malloc_0_nonnull = yes; then : - -$as_echo "@%:@define HAVE_MALLOC 1" >>confdefs.h - -else - $as_echo "@%:@define HAVE_MALLOC 0" >>confdefs.h - - case " $LIB@&t@OBJS " in - *" malloc.$ac_objext "* ) ;; - *) LIB@&t@OBJS="$LIB@&t@OBJS malloc.$ac_objext" - ;; -esac - - -$as_echo "@%:@define malloc rpl_malloc" >>confdefs.h - -fi - - - - - -{ $as_echo "$as_me:${as_lineno-$LINENO}: checking Fortran 90 module inclusion flag" >&5 -$as_echo_n "checking Fortran 90 module inclusion flag... " >&6; } -if ${ac_cv_fc_module_flag+:} false; then : - $as_echo_n "(cached) " >&6 -else - ac_ext=${ac_fc_srcext-f} -ac_compile='$FC -c $FCFLAGS $ac_fcflags_srcext conftest.$ac_ext >&5' -ac_link='$FC -o conftest$ac_exeext $FCFLAGS $LDFLAGS $ac_fcflags_srcext conftest.$ac_ext $LIBS >&5' -ac_compiler_gnu=$ac_cv_fc_compiler_gnu - -ac_cv_fc_module_flag=unknown -mkdir conftest.dir -cd conftest.dir -cat > conftest.$ac_ext <<_ACEOF - - module conftest_module - contains - subroutine conftest_routine - write(*,'(a)') 'gotcha!' - end subroutine - end module -_ACEOF -if ac_fn_fc_try_compile "$LINENO"; then : - cd .. - ac_fc_module_flag_FCFLAGS_save=$FCFLAGS - # Flag ordering is significant for gfortran and Sun. - for ac_flag in -M -I '-I ' '-M ' -p '-mod ' '-module ' '-Am -I'; do - # Add the flag twice to prevent matching an output flag. - FCFLAGS="$ac_fc_module_flag_FCFLAGS_save ${ac_flag}conftest.dir ${ac_flag}conftest.dir" - cat > conftest.$ac_ext <<_ACEOF - - program main - use conftest_module - call conftest_routine - end program -_ACEOF -if ac_fn_fc_try_compile "$LINENO"; then : - ac_cv_fc_module_flag="$ac_flag" -fi -rm -f core conftest.err conftest.$ac_objext conftest.$ac_ext - if test "$ac_cv_fc_module_flag" != unknown; then - break - fi - done - FCFLAGS=$ac_fc_module_flag_FCFLAGS_save - -fi -rm -f core conftest.err conftest.$ac_objext conftest.$ac_ext -rm -rf conftest.dir -ac_ext=c -ac_cpp='$CPP $CPPFLAGS' -ac_compile='$CC -c $CFLAGS $CPPFLAGS conftest.$ac_ext >&5' -ac_link='$CC -o conftest$ac_exeext $CFLAGS $CPPFLAGS $LDFLAGS conftest.$ac_ext $LIBS >&5' -ac_compiler_gnu=$ac_cv_c_compiler_gnu - - -fi -{ $as_echo "$as_me:${as_lineno-$LINENO}: result: $ac_cv_fc_module_flag" >&5 -$as_echo "$ac_cv_fc_module_flag" >&6; } -if test "$ac_cv_fc_module_flag" != unknown; then - FC_MODINC=$ac_cv_fc_module_flag - -else - FC_MODINC= - as_fn_error $? "unable to find compiler flag for module search path" "$LINENO" 5 -fi - -# Ensure trailing whitespace is preserved in a Makefile. -ac_empty="" - - - -{ $as_echo "$as_me:${as_lineno-$LINENO}: checking Fortran 90 module output flag" >&5 -$as_echo_n "checking Fortran 90 module output flag... " >&6; } -if ${ac_cv_fc_module_output_flag+:} false; then : - $as_echo_n "(cached) " >&6 -else - ac_ext=${ac_fc_srcext-f} -ac_compile='$FC -c $FCFLAGS $ac_fcflags_srcext conftest.$ac_ext >&5' -ac_link='$FC -o conftest$ac_exeext $FCFLAGS $LDFLAGS $ac_fcflags_srcext conftest.$ac_ext $LIBS >&5' -ac_compiler_gnu=$ac_cv_fc_compiler_gnu - -mkdir conftest.dir conftest.dir/sub -cd conftest.dir -ac_cv_fc_module_output_flag=unknown -ac_fc_module_output_flag_FCFLAGS_save=$FCFLAGS -# Flag ordering is significant: put flags late which some compilers use -# for the search path. -for ac_flag in -J '-J ' -fmod= -moddir= +moddir= -qmoddir= '-mod ' \ - '-module ' -M '-Am -M' '-e m -J '; do - FCFLAGS="$ac_fc_module_output_flag_FCFLAGS_save ${ac_flag}sub" - cat > conftest.$ac_ext <<_ACEOF - - module conftest_module - contains - subroutine conftest_routine - write(*,'(a)') 'gotcha!' - end subroutine - end module -_ACEOF -if ac_fn_fc_try_compile "$LINENO"; then : - cd sub - cat > conftest.$ac_ext <<_ACEOF - - program main - use conftest_module - call conftest_routine - end program -_ACEOF -if ac_fn_fc_try_compile "$LINENO"; then : - ac_cv_fc_module_output_flag="$ac_flag" -fi -rm -f core conftest.err conftest.$ac_objext conftest.$ac_ext - cd .. - if test "$ac_cv_fc_module_output_flag" != unknown; then - break - fi -fi -rm -f core conftest.err conftest.$ac_objext conftest.$ac_ext -done -FCFLAGS=$ac_fc_module_output_flag_FCFLAGS_save -cd .. -rm -rf conftest.dir -ac_ext=c -ac_cpp='$CPP $CPPFLAGS' -ac_compile='$CC -c $CFLAGS $CPPFLAGS conftest.$ac_ext >&5' -ac_link='$CC -o conftest$ac_exeext $CFLAGS $CPPFLAGS $LDFLAGS conftest.$ac_ext $LIBS >&5' -ac_compiler_gnu=$ac_cv_c_compiler_gnu - - -fi -{ $as_echo "$as_me:${as_lineno-$LINENO}: result: $ac_cv_fc_module_output_flag" >&5 -$as_echo "$ac_cv_fc_module_output_flag" >&6; } -if test "$ac_cv_fc_module_output_flag" != unknown; then - FC_MODOUT=$ac_cv_fc_module_output_flag - -else - FC_MODOUT= - as_fn_error $? "unable to find compiler flag to write module information to" "$LINENO" 5 -fi - -# Ensure trailing whitespace is preserved in a Makefile. -ac_empty="" - - -{ $as_echo "$as_me:${as_lineno-$LINENO}: checking Fortran 90 module extension" >&5 -$as_echo_n "checking Fortran 90 module extension... " >&6; } -if ${ac_cv_fc_module_ext+:} false; then : - $as_echo_n "(cached) " >&6 -else - ac_ext=${ac_fc_srcext-f} -ac_compile='$FC -c $FCFLAGS $ac_fcflags_srcext conftest.$ac_ext >&5' -ac_link='$FC -o conftest$ac_exeext $FCFLAGS $LDFLAGS $ac_fcflags_srcext conftest.$ac_ext $LIBS >&5' -ac_compiler_gnu=$ac_cv_fc_compiler_gnu - -mkdir conftest.dir -cd conftest.dir -ac_cv_fc_module_ext=unknown -cat > conftest.$ac_ext <<_ACEOF - - module conftest_module - contains - subroutine conftest_routine - write(*,'(a)') 'gotcha!' - end subroutine - end module -_ACEOF -if ac_fn_fc_try_compile "$LINENO"; then : - ac_cv_fc_module_ext=`ls | sed -n 's,conftest_module\.,,p'` - if test x$ac_cv_fc_module_ext = x; then - ac_cv_fc_module_ext=`ls | sed -n 's,CONFTEST_MODULE\.,,p'` - fi -fi -rm -f core conftest.err conftest.$ac_objext conftest.$ac_ext -cd .. -rm -rf conftest.dir -ac_ext=c -ac_cpp='$CPP $CPPFLAGS' -ac_compile='$CC -c $CFLAGS $CPPFLAGS conftest.$ac_ext >&5' -ac_link='$CC -o conftest$ac_exeext $CFLAGS $CPPFLAGS $LDFLAGS conftest.$ac_ext $LIBS >&5' -ac_compiler_gnu=$ac_cv_c_compiler_gnu - - -fi -{ $as_echo "$as_me:${as_lineno-$LINENO}: result: $ac_cv_fc_module_ext" >&5 -$as_echo "$ac_cv_fc_module_ext" >&6; } -FC_MODEXT=$ac_cv_fc_module_ext -if test "$FC_MODEXT" = unknown; then - FC_MODEXT= -fi - - - -case $build in - *solaris*) - CFITS_LIBS="-lnsl -lsocket" - ;; - *) - ;; -esac - -for ac_header in fitsio.h -do : - ac_fn_c_check_header_mongrel "$LINENO" "fitsio.h" "ac_cv_header_fitsio_h" "$ac_includes_default" -if test "x$ac_cv_header_fitsio_h" = xyes; then : - cat >>confdefs.h <<_ACEOF -@%:@define HAVE_FITSIO_H 1 -_ACEOF - -fi - -done - -{ $as_echo "$as_me:${as_lineno-$LINENO}: checking for ffclos in -lcfitsio" >&5 -$as_echo_n "checking for ffclos in -lcfitsio... " >&6; } -if ${ac_cv_lib_cfitsio_ffclos+:} false; then : - $as_echo_n "(cached) " >&6 -else - ac_check_lib_save_LIBS=$LIBS -LIBS="-lcfitsio $CFITS_LIBS -lm $LIBS" -cat confdefs.h - <<_ACEOF >conftest.$ac_ext -/* end confdefs.h. */ - -/* Override any GCC internal prototype to avoid an error. - Use char because int might match the return type of a GCC - builtin and then its argument prototype would still apply. */ -#ifdef __cplusplus -extern "C" -#endif -char ffclos (); -int -main () -{ -return ffclos (); - ; - return 0; -} -_ACEOF -if ac_fn_c_try_link "$LINENO"; then : - ac_cv_lib_cfitsio_ffclos=yes -else - ac_cv_lib_cfitsio_ffclos=no -fi -rm -f core conftest.err conftest.$ac_objext \ - conftest$ac_exeext conftest.$ac_ext -LIBS=$ac_check_lib_save_LIBS -fi -{ $as_echo "$as_me:${as_lineno-$LINENO}: result: $ac_cv_lib_cfitsio_ffclos" >&5 -$as_echo "$ac_cv_lib_cfitsio_ffclos" >&6; } -if test "x$ac_cv_lib_cfitsio_ffclos" = xyes; then : - LIBCFITSIO=-lcfitsio - -else - as_fn_error $? "cFITSIO library not found." "$LINENO" 5 -fi - - -{ $as_echo "$as_me:${as_lineno-$LINENO}: checking for lmder_ in -lminpack" >&5 -$as_echo_n "checking for lmder_ in -lminpack... " >&6; } -if ${ac_cv_lib_minpack_lmder_+:} false; then : - $as_echo_n "(cached) " >&6 -else - ac_check_lib_save_LIBS=$LIBS -LIBS="-lminpack $LIBS" -cat confdefs.h - <<_ACEOF >conftest.$ac_ext -/* end confdefs.h. */ - -/* Override any GCC internal prototype to avoid an error. - Use char because int might match the return type of a GCC - builtin and then its argument prototype would still apply. */ -#ifdef __cplusplus -extern "C" -#endif -char lmder_ (); -int -main () -{ -return lmder_ (); - ; - return 0; -} -_ACEOF -if ac_fn_c_try_link "$LINENO"; then : - ac_cv_lib_minpack_lmder_=yes -else - ac_cv_lib_minpack_lmder_=no -fi -rm -f core conftest.err conftest.$ac_objext \ - conftest$ac_exeext conftest.$ac_ext -LIBS=$ac_check_lib_save_LIBS -fi -{ $as_echo "$as_me:${as_lineno-$LINENO}: result: $ac_cv_lib_minpack_lmder_" >&5 -$as_echo "$ac_cv_lib_minpack_lmder_" >&6; } -if test "x$ac_cv_lib_minpack_lmder_" = xyes; then : - cat >>confdefs.h <<_ACEOF -@%:@define HAVE_LIBMINPACK 1 -_ACEOF - - LIBS="-lminpack $LIBS" - -else - - ac_ext=f -ac_compile='$F77 -c $FFLAGS conftest.$ac_ext >&5' -ac_link='$F77 -o conftest$ac_exeext $FFLAGS $LDFLAGS conftest.$ac_ext $LIBS >&5' -ac_compiler_gnu=$ac_cv_f77_compiler_gnu -if test -n "$ac_tool_prefix"; then - for ac_prog in g77 xlf f77 frt pgf77 cf77 fort77 fl32 af77 xlf90 f90 pgf90 pghpf epcf90 gfortran g95 xlf95 f95 fort ifort ifc efc pgfortran pgf95 lf95 ftn nagfor - do - # Extract the first word of "$ac_tool_prefix$ac_prog", so it can be a program name with args. -set dummy $ac_tool_prefix$ac_prog; ac_word=$2 -{ $as_echo "$as_me:${as_lineno-$LINENO}: checking for $ac_word" >&5 -$as_echo_n "checking for $ac_word... " >&6; } -if ${ac_cv_prog_F77+:} false; then : - $as_echo_n "(cached) " >&6 -else - if test -n "$F77"; then - ac_cv_prog_F77="$F77" # Let the user override the test. -else -as_save_IFS=$IFS; IFS=$PATH_SEPARATOR -for as_dir in $PATH -do - IFS=$as_save_IFS - test -z "$as_dir" && as_dir=. - for ac_exec_ext in '' $ac_executable_extensions; do - if as_fn_executable_p "$as_dir/$ac_word$ac_exec_ext"; then - ac_cv_prog_F77="$ac_tool_prefix$ac_prog" - $as_echo "$as_me:${as_lineno-$LINENO}: found $as_dir/$ac_word$ac_exec_ext" >&5 - break 2 - fi -done - done -IFS=$as_save_IFS - -fi -fi -F77=$ac_cv_prog_F77 -if test -n "$F77"; then - { $as_echo "$as_me:${as_lineno-$LINENO}: result: $F77" >&5 -$as_echo "$F77" >&6; } -else - { $as_echo "$as_me:${as_lineno-$LINENO}: result: no" >&5 -$as_echo "no" >&6; } -fi - - - test -n "$F77" && break - done -fi -if test -z "$F77"; then - ac_ct_F77=$F77 - for ac_prog in g77 xlf f77 frt pgf77 cf77 fort77 fl32 af77 xlf90 f90 pgf90 pghpf epcf90 gfortran g95 xlf95 f95 fort ifort ifc efc pgfortran pgf95 lf95 ftn nagfor -do - # Extract the first word of "$ac_prog", so it can be a program name with args. -set dummy $ac_prog; ac_word=$2 -{ $as_echo "$as_me:${as_lineno-$LINENO}: checking for $ac_word" >&5 -$as_echo_n "checking for $ac_word... " >&6; } -if ${ac_cv_prog_ac_ct_F77+:} false; then : - $as_echo_n "(cached) " >&6 -else - if test -n "$ac_ct_F77"; then - ac_cv_prog_ac_ct_F77="$ac_ct_F77" # Let the user override the test. -else -as_save_IFS=$IFS; IFS=$PATH_SEPARATOR -for as_dir in $PATH -do - IFS=$as_save_IFS - test -z "$as_dir" && as_dir=. - for ac_exec_ext in '' $ac_executable_extensions; do - if as_fn_executable_p "$as_dir/$ac_word$ac_exec_ext"; then - ac_cv_prog_ac_ct_F77="$ac_prog" - $as_echo "$as_me:${as_lineno-$LINENO}: found $as_dir/$ac_word$ac_exec_ext" >&5 - break 2 - fi -done - done -IFS=$as_save_IFS - -fi -fi -ac_ct_F77=$ac_cv_prog_ac_ct_F77 -if test -n "$ac_ct_F77"; then - { $as_echo "$as_me:${as_lineno-$LINENO}: result: $ac_ct_F77" >&5 -$as_echo "$ac_ct_F77" >&6; } -else - { $as_echo "$as_me:${as_lineno-$LINENO}: result: no" >&5 -$as_echo "no" >&6; } -fi - - - test -n "$ac_ct_F77" && break -done - - if test "x$ac_ct_F77" = x; then - F77="" - else - case $cross_compiling:$ac_tool_warned in -yes:) -{ $as_echo "$as_me:${as_lineno-$LINENO}: WARNING: using cross tools not prefixed with host triplet" >&5 -$as_echo "$as_me: WARNING: using cross tools not prefixed with host triplet" >&2;} -ac_tool_warned=yes ;; -esac - F77=$ac_ct_F77 - fi -fi - - -# Provide some information about the compiler. -$as_echo "$as_me:${as_lineno-$LINENO}: checking for Fortran 77 compiler version" >&5 -set X $ac_compile -ac_compiler=$2 -for ac_option in --version -v -V -qversion; do - { { ac_try="$ac_compiler $ac_option >&5" -case "(($ac_try" in - *\"* | *\`* | *\\*) ac_try_echo=\$ac_try;; - *) ac_try_echo=$ac_try;; -esac -eval ac_try_echo="\"\$as_me:${as_lineno-$LINENO}: $ac_try_echo\"" -$as_echo "$ac_try_echo"; } >&5 - (eval "$ac_compiler $ac_option >&5") 2>conftest.err - ac_status=$? - if test -s conftest.err; then - sed '10a\ -... rest of stderr output deleted ... - 10q' conftest.err >conftest.er1 - cat conftest.er1 >&5 - fi - rm -f conftest.er1 conftest.err - $as_echo "$as_me:${as_lineno-$LINENO}: \$? = $ac_status" >&5 - test $ac_status = 0; } -done -rm -f a.out - -# If we don't use `.F' as extension, the preprocessor is not run on the -# input file. (Note that this only needs to work for GNU compilers.) -ac_save_ext=$ac_ext -ac_ext=F -{ $as_echo "$as_me:${as_lineno-$LINENO}: checking whether we are using the GNU Fortran 77 compiler" >&5 -$as_echo_n "checking whether we are using the GNU Fortran 77 compiler... " >&6; } -if ${ac_cv_f77_compiler_gnu+:} false; then : - $as_echo_n "(cached) " >&6 -else - cat > conftest.$ac_ext <<_ACEOF - program main -#ifndef __GNUC__ - choke me -#endif - - end -_ACEOF -if ac_fn_f77_try_compile "$LINENO"; then : - ac_compiler_gnu=yes -else - ac_compiler_gnu=no -fi -rm -f core conftest.err conftest.$ac_objext conftest.$ac_ext -ac_cv_f77_compiler_gnu=$ac_compiler_gnu - -fi -{ $as_echo "$as_me:${as_lineno-$LINENO}: result: $ac_cv_f77_compiler_gnu" >&5 -$as_echo "$ac_cv_f77_compiler_gnu" >&6; } -ac_ext=$ac_save_ext -ac_test_FFLAGS=${FFLAGS+set} -ac_save_FFLAGS=$FFLAGS -FFLAGS= -{ $as_echo "$as_me:${as_lineno-$LINENO}: checking whether $F77 accepts -g" >&5 -$as_echo_n "checking whether $F77 accepts -g... " >&6; } -if ${ac_cv_prog_f77_g+:} false; then : - $as_echo_n "(cached) " >&6 -else - FFLAGS=-g -cat > conftest.$ac_ext <<_ACEOF - program main - - end -_ACEOF -if ac_fn_f77_try_compile "$LINENO"; then : - ac_cv_prog_f77_g=yes -else - ac_cv_prog_f77_g=no -fi -rm -f core conftest.err conftest.$ac_objext conftest.$ac_ext - -fi -{ $as_echo "$as_me:${as_lineno-$LINENO}: result: $ac_cv_prog_f77_g" >&5 -$as_echo "$ac_cv_prog_f77_g" >&6; } -if test "$ac_test_FFLAGS" = set; then - FFLAGS=$ac_save_FFLAGS -elif test $ac_cv_prog_f77_g = yes; then - if test "x$ac_cv_f77_compiler_gnu" = xyes; then - FFLAGS="-g -O2" - else - FFLAGS="-g" - fi -else - if test "x$ac_cv_f77_compiler_gnu" = xyes; then - FFLAGS="-O2" - else - FFLAGS= - fi -fi - -if test $ac_compiler_gnu = yes; then - G77=yes -else - G77= -fi -ac_ext=c -ac_cpp='$CPP $CPPFLAGS' -ac_compile='$CC -c $CFLAGS $CPPFLAGS conftest.$ac_ext >&5' -ac_link='$CC -o conftest$ac_exeext $CFLAGS $CPPFLAGS $LDFLAGS conftest.$ac_ext $LIBS >&5' -ac_compiler_gnu=$ac_cv_c_compiler_gnu - - MINPACKDIR=minpack - - LDMINPACK=-L../minpack - - -fi - - -@%:@ Check whether --enable-vo was given. -if test "${enable_vo+set}" = set; then : - enableval=$enable_vo; disable_vo=yes -else - disable_vo=no -fi - -@%:@ Check whether --enable-cli was given. -if test "${enable_cli+set}" = set; then : - enableval=$enable_cli; disable_cli=yes -else - disable_cli=no -fi - -@%:@ Check whether --enable-gui was given. -if test "${enable_gui+set}" = set; then : - enableval=$enable_gui; disable_gui=yes -else - disable_gui=no -fi - - -if test "x$disable_cli" = "xno" -o "x$disable_vo" = "xno" -o "x$disable_gui" = "xno"; then - - - -@%:@ Check whether --with-wxdir was given. -if test "${with_wxdir+set}" = set; then : - withval=$with_wxdir; wx_config_name="$withval/wx-config" - wx_config_args="--inplace" -fi - - -@%:@ Check whether --with-wx-config was given. -if test "${with_wx_config+set}" = set; then : - withval=$with_wx_config; wx_config_name="$withval" -fi - - -@%:@ Check whether --with-wx-prefix was given. -if test "${with_wx_prefix+set}" = set; then : - withval=$with_wx_prefix; wx_config_prefix="$withval" -else - wx_config_prefix="" -fi - - -@%:@ Check whether --with-wx-exec-prefix was given. -if test "${with_wx_exec_prefix+set}" = set; then : - withval=$with_wx_exec_prefix; wx_config_exec_prefix="$withval" -else - wx_config_exec_prefix="" -fi - - - - - if test x${WX_CONFIG_NAME+set} != xset ; then - WX_CONFIG_NAME=wx-config - fi - - if test "x$wx_config_name" != x ; then - WX_CONFIG_NAME="$wx_config_name" - fi - - if test x$wx_config_exec_prefix != x ; then - wx_config_args="$wx_config_args --exec-prefix=$wx_config_exec_prefix" - WX_LOOKUP_PATH="$wx_config_exec_prefix/bin" - fi - if test x$wx_config_prefix != x ; then - wx_config_args="$wx_config_args --prefix=$wx_config_prefix" - WX_LOOKUP_PATH="$WX_LOOKUP_PATH:$wx_config_prefix/bin" - fi - if test "$cross_compiling" = "yes"; then - wx_config_args="$wx_config_args --host=$host_alias" - fi - - if test -x "$WX_CONFIG_NAME" ; then - { $as_echo "$as_me:${as_lineno-$LINENO}: checking for wx-config" >&5 -$as_echo_n "checking for wx-config... " >&6; } - WX_CONFIG_PATH="$WX_CONFIG_NAME" - { $as_echo "$as_me:${as_lineno-$LINENO}: result: $WX_CONFIG_PATH" >&5 -$as_echo "$WX_CONFIG_PATH" >&6; } - else - # Extract the first word of "$WX_CONFIG_NAME", so it can be a program name with args. -set dummy $WX_CONFIG_NAME; ac_word=$2 -{ $as_echo "$as_me:${as_lineno-$LINENO}: checking for $ac_word" >&5 -$as_echo_n "checking for $ac_word... " >&6; } -if ${ac_cv_path_WX_CONFIG_PATH+:} false; then : - $as_echo_n "(cached) " >&6 -else - case $WX_CONFIG_PATH in - [\\/]* | ?:[\\/]*) - ac_cv_path_WX_CONFIG_PATH="$WX_CONFIG_PATH" # Let the user override the test with a path. - ;; - *) - as_save_IFS=$IFS; IFS=$PATH_SEPARATOR -as_dummy=""$WX_LOOKUP_PATH:$PATH"" -for as_dir in $as_dummy -do - IFS=$as_save_IFS - test -z "$as_dir" && as_dir=. - for ac_exec_ext in '' $ac_executable_extensions; do - if as_fn_executable_p "$as_dir/$ac_word$ac_exec_ext"; then - ac_cv_path_WX_CONFIG_PATH="$as_dir/$ac_word$ac_exec_ext" - $as_echo "$as_me:${as_lineno-$LINENO}: found $as_dir/$ac_word$ac_exec_ext" >&5 - break 2 - fi -done - done -IFS=$as_save_IFS - - test -z "$ac_cv_path_WX_CONFIG_PATH" && ac_cv_path_WX_CONFIG_PATH="no" - ;; -esac -fi -WX_CONFIG_PATH=$ac_cv_path_WX_CONFIG_PATH -if test -n "$WX_CONFIG_PATH"; then - { $as_echo "$as_me:${as_lineno-$LINENO}: result: $WX_CONFIG_PATH" >&5 -$as_echo "$WX_CONFIG_PATH" >&6; } -else - { $as_echo "$as_me:${as_lineno-$LINENO}: result: no" >&5 -$as_echo "no" >&6; } -fi - - - fi - - if test "$WX_CONFIG_PATH" != "no" ; then - WX_VERSION="" - - min_wx_version=3.0.0 - if test -z "" ; then - { $as_echo "$as_me:${as_lineno-$LINENO}: checking for wxWidgets version >= $min_wx_version" >&5 -$as_echo_n "checking for wxWidgets version >= $min_wx_version... " >&6; } - else - { $as_echo "$as_me:${as_lineno-$LINENO}: checking for wxWidgets version >= $min_wx_version ()" >&5 -$as_echo_n "checking for wxWidgets version >= $min_wx_version ()... " >&6; } - fi - - WX_CONFIG_WITH_ARGS="$WX_CONFIG_PATH $wx_config_args " - - WX_VERSION=`$WX_CONFIG_WITH_ARGS --version 2>/dev/null` - wx_config_major_version=`echo $WX_VERSION | \ - sed 's/\([0-9]*\).\([0-9]*\).\([0-9]*\)/\1/'` - wx_config_minor_version=`echo $WX_VERSION | \ - sed 's/\([0-9]*\).\([0-9]*\).\([0-9]*\)/\2/'` - wx_config_micro_version=`echo $WX_VERSION | \ - sed 's/\([0-9]*\).\([0-9]*\).\([0-9]*\)/\3/'` - - wx_requested_major_version=`echo $min_wx_version | \ - sed 's/\([0-9]*\).\([0-9]*\).\([0-9]*\)/\1/'` - wx_requested_minor_version=`echo $min_wx_version | \ - sed 's/\([0-9]*\).\([0-9]*\).\([0-9]*\)/\2/'` - wx_requested_micro_version=`echo $min_wx_version | \ - sed 's/\([0-9]*\).\([0-9]*\).\([0-9]*\)/\3/'` - - - wx_ver_ok="" - if test "x$WX_VERSION" != x ; then - if test $wx_config_major_version -gt $wx_requested_major_version; then - wx_ver_ok=yes - else - if test $wx_config_major_version -eq $wx_requested_major_version; then - if test $wx_config_minor_version -gt $wx_requested_minor_version; then - wx_ver_ok=yes - else - if test $wx_config_minor_version -eq $wx_requested_minor_version; then - if test $wx_config_micro_version -ge $wx_requested_micro_version; then - wx_ver_ok=yes - fi - fi - fi - fi - fi - fi - - - if test -n "$wx_ver_ok"; then - { $as_echo "$as_me:${as_lineno-$LINENO}: result: yes (version $WX_VERSION)" >&5 -$as_echo "yes (version $WX_VERSION)" >&6; } - WX_LIBS=`$WX_CONFIG_WITH_ARGS --libs ` - - { $as_echo "$as_me:${as_lineno-$LINENO}: checking for wxWidgets static library" >&5 -$as_echo_n "checking for wxWidgets static library... " >&6; } - WX_LIBS_STATIC=`$WX_CONFIG_WITH_ARGS --static --libs 2>/dev/null` - if test "x$WX_LIBS_STATIC" = "x"; then - { $as_echo "$as_me:${as_lineno-$LINENO}: result: no" >&5 -$as_echo "no" >&6; } - else - { $as_echo "$as_me:${as_lineno-$LINENO}: result: yes" >&5 -$as_echo "yes" >&6; } - fi - - wx_has_cppflags="" - if test $wx_config_major_version -gt 2; then - wx_has_cppflags=yes - else - if test $wx_config_major_version -eq 2; then - if test $wx_config_minor_version -gt 2; then - wx_has_cppflags=yes - else - if test $wx_config_minor_version -eq 2; then - if test $wx_config_micro_version -ge 6; then - wx_has_cppflags=yes - fi - fi - fi - fi - fi - - wx_has_rescomp="" - if test $wx_config_major_version -gt 2; then - wx_has_rescomp=yes - else - if test $wx_config_major_version -eq 2; then - if test $wx_config_minor_version -ge 7; then - wx_has_rescomp=yes - fi - fi - fi - if test "x$wx_has_rescomp" = x ; then - WX_RESCOMP= - else - WX_RESCOMP=`$WX_CONFIG_WITH_ARGS --rescomp` - fi - - if test "x$wx_has_cppflags" = x ; then - WX_CFLAGS=`$WX_CONFIG_WITH_ARGS --cflags ` - WX_CPPFLAGS=$WX_CFLAGS - WX_CXXFLAGS=$WX_CFLAGS - - WX_CFLAGS_ONLY=$WX_CFLAGS - WX_CXXFLAGS_ONLY=$WX_CFLAGS - else - WX_CPPFLAGS=`$WX_CONFIG_WITH_ARGS --cppflags ` - WX_CXXFLAGS=`$WX_CONFIG_WITH_ARGS --cxxflags ` - WX_CFLAGS=`$WX_CONFIG_WITH_ARGS --cflags ` - - WX_CFLAGS_ONLY=`echo $WX_CFLAGS | sed "s@^$WX_CPPFLAGS *@@"` - WX_CXXFLAGS_ONLY=`echo $WX_CXXFLAGS | sed "s@^$WX_CFLAGS *@@"` - fi - - wxWin=1 - - else - - if test "x$WX_VERSION" = x; then - { $as_echo "$as_me:${as_lineno-$LINENO}: result: no" >&5 -$as_echo "no" >&6; } - else - { $as_echo "$as_me:${as_lineno-$LINENO}: result: no (version $WX_VERSION is not new enough)" >&5 -$as_echo "no (version $WX_VERSION is not new enough)" >&6; } - fi - - WX_CFLAGS="" - WX_CPPFLAGS="" - WX_CXXFLAGS="" - WX_LIBS="" - WX_LIBS_STATIC="" - WX_RESCOMP="" - - if test ! -z ""; then - - wx_error_message=" - The configuration you asked for $PACKAGE_NAME requires a wxWidgets - build with the following settings: - - but such build is not available. - - To see the wxWidgets builds available on this system, please use - 'wx-config --list' command. To use the default build, returned by - 'wx-config --selected-config', use the options with their 'auto' - default values." - - fi - - wx_error_message=" - The requested wxWidgets build couldn't be found. - $wx_error_message - - If you still get this error, then check that 'wx-config' is - in path, the directory where wxWidgets libraries are installed - (returned by 'wx-config --libs' command) is in LD_LIBRARY_PATH - or equivalent variable and wxWidgets version is 3.0.0 or above." - - as_fn_error $? "$wx_error_message" "$LINENO" 5 - - fi - else - - WX_CFLAGS="" - WX_CPPFLAGS="" - WX_CXXFLAGS="" - WX_LIBS="" - WX_LIBS_STATIC="" - WX_RESCOMP="" - - : - - fi - - - - - - - - - - - - WX_VERSION_MAJOR="$wx_config_major_version" - WX_VERSION_MINOR="$wx_config_minor_version" - WX_VERSION_MICRO="$wx_config_micro_version" - - - - - - - if test -z "$wxWin"; then - - { $as_echo "$as_me:${as_lineno-$LINENO}: WARNING: - - wxWidgets toolkit not found! - - Continuing without wxWidgets. - These parts may be unavailable (even required on command-line): - - * Both graphical and command-line interfaces - * Any functionality related to Virtual observatory - - Otherwise: - - Install wxWidgets on your system - - Please check: wx-config is available in PATH, a directory - where wxWidgets libraries are installed (returned by - 'wx-config --libs' command) is in LD_LIBRARY_PATH or - equivalent variable and appropriate wxWidgets version - is available. - " >&5 -$as_echo "$as_me: WARNING: - - wxWidgets toolkit not found! - - Continuing without wxWidgets. - These parts may be unavailable (even required on command-line): - - * Both graphical and command-line interfaces - * Any functionality related to Virtual observatory - - Otherwise: - - Install wxWidgets on your system - - Please check: wx-config is available in PATH, a directory - where wxWidgets libraries are installed (returned by - 'wx-config --libs' command) is in LD_LIBRARY_PATH or - equivalent variable and appropriate wxWidgets version - is available. - " >&2;} - - fi -fi - - -wxVO="no" -wxGUI="no" -wxCLI="no" - -if test "$wxWin" = 1; then - - if test "x$disable_gui" = "xno"; then - wxGUI="yes" - XMUNIPACKDIR=xmunipack - - MATPLOTDIR=wxMathPlot - - fi - - if test "x$disable_cli" = "xno"; then - wxCLI="yes" - MUNIPACKDIR=munipack - - WX_CXXFLAGS_CLI=`wx-config --cxxflags base` - - WX_LIBS_CLI=`wx-config --libs base` - - fi - - if test "x$disable_vo" = "xno"; then - wxVO="yes" - WX_LIBS_VO=`wx-config --libs base,net,xml` - - WX_CXXFLAGS_VO=`wx-config --cxxflags base,net,xml` - - VODIR=vo - - fi -fi - -@%:@ Check whether --enable-bundle was given. -if test "${enable_bundle+set}" = set; then : - enableval=$enable_bundle; enable_bundle=yes -else - enable_bundle=no -fi - - if test "x$enable_bundle" = "xyes"; then - BUNDLE_TRUE= - BUNDLE_FALSE='#' -else - BUNDLE_TRUE='#' - BUNDLE_FALSE= -fi - - - - -if test "x$enable_bundle" = "xyes"; then - BUNDLEDIR=${BUNDLEDIR:-/opt/munipack} - - LIBGFORTRAN=-static-libgfortran - - LIBGCC=-static-libgcc - - LIBSTDCPP=-static-libstdc++ - -fi - -CLEANFILES=*.$FC_MODEXT - - - -ac_config_headers="$ac_config_headers config.h" - - -ac_config_files="$ac_config_files minpack/Makefile lib/Makefile preprocess/Makefile kombine/Makefile photometry/Makefile artificial/Makefile fitsut/Makefile list/Makefile astrometry/Makefile coloring/Makefile vo/Makefile munipack/Makefile wxMathPlot/Makefile xmunipack/Makefile doc/Makefile Makefile" - - -cat >confcache <<\_ACEOF -# This file is a shell script that caches the results of configure -# tests run on this system so they can be shared between configure -# scripts and configure runs, see configure's option --config-cache. -# It is not useful on other systems. If it contains results you don't -# want to keep, you may remove or edit it. -# -# config.status only pays attention to the cache file if you give it -# the --recheck option to rerun configure. -# -# `ac_cv_env_foo' variables (set or unset) will be overridden when -# loading this file, other *unset* `ac_cv_foo' will be assigned the -# following values. - -_ACEOF - -# The following way of writing the cache mishandles newlines in values, -# but we know of no workaround that is simple, portable, and efficient. -# So, we kill variables containing newlines. -# Ultrix sh set writes to stderr and can't be redirected directly, -# and sets the high bit in the cache file unless we assign to the vars. -( - for ac_var in `(set) 2>&1 | sed -n 's/^\([a-zA-Z_][a-zA-Z0-9_]*\)=.*/\1/p'`; do - eval ac_val=\$$ac_var - case $ac_val in #( - *${as_nl}*) - case $ac_var in #( - *_cv_*) { $as_echo "$as_me:${as_lineno-$LINENO}: WARNING: cache variable $ac_var contains a newline" >&5 -$as_echo "$as_me: WARNING: cache variable $ac_var contains a newline" >&2;} ;; - esac - case $ac_var in #( - _ | IFS | as_nl) ;; #( - BASH_ARGV | BASH_SOURCE) eval $ac_var= ;; #( - *) { eval $ac_var=; unset $ac_var;} ;; - esac ;; - esac - done - - (set) 2>&1 | - case $as_nl`(ac_space=' '; set) 2>&1` in #( - *${as_nl}ac_space=\ *) - # `set' does not quote correctly, so add quotes: double-quote - # substitution turns \\\\ into \\, and sed turns \\ into \. - sed -n \ - "s/'/'\\\\''/g; - s/^\\([_$as_cr_alnum]*_cv_[_$as_cr_alnum]*\\)=\\(.*\\)/\\1='\\2'/p" - ;; #( - *) - # `set' quotes correctly as required by POSIX, so do not add quotes. - sed -n "/^[_$as_cr_alnum]*_cv_[_$as_cr_alnum]*=/p" - ;; - esac | - sort -) | - sed ' - /^ac_cv_env_/b end - t clear - :clear - s/^\([^=]*\)=\(.*[{}].*\)$/test "${\1+set}" = set || &/ - t end - s/^\([^=]*\)=\(.*\)$/\1=${\1=\2}/ - :end' >>confcache -if diff "$cache_file" confcache >/dev/null 2>&1; then :; else - if test -w "$cache_file"; then - if test "x$cache_file" != "x/dev/null"; then - { $as_echo "$as_me:${as_lineno-$LINENO}: updating cache $cache_file" >&5 -$as_echo "$as_me: updating cache $cache_file" >&6;} - if test ! -f "$cache_file" || test -h "$cache_file"; then - cat confcache >"$cache_file" - else - case $cache_file in #( - */* | ?:*) - mv -f confcache "$cache_file"$$ && - mv -f "$cache_file"$$ "$cache_file" ;; #( - *) - mv -f confcache "$cache_file" ;; - esac - fi - fi - else - { $as_echo "$as_me:${as_lineno-$LINENO}: not updating unwritable cache $cache_file" >&5 -$as_echo "$as_me: not updating unwritable cache $cache_file" >&6;} - fi -fi -rm -f confcache - -test "x$prefix" = xNONE && prefix=$ac_default_prefix -# Let make expand exec_prefix. -test "x$exec_prefix" = xNONE && exec_prefix='${prefix}' - -DEFS=-DHAVE_CONFIG_H - -ac_libobjs= -ac_ltlibobjs= -U= -for ac_i in : $LIB@&t@OBJS; do test "x$ac_i" = x: && continue - # 1. Remove the extension, and $U if already installed. - ac_script='s/\$U\././;s/\.o$//;s/\.obj$//' - ac_i=`$as_echo "$ac_i" | sed "$ac_script"` - # 2. Prepend LIBOBJDIR. When used with automake>=1.10 LIBOBJDIR - # will be set to the directory where LIBOBJS objects are built. - as_fn_append ac_libobjs " \${LIBOBJDIR}$ac_i\$U.$ac_objext" - as_fn_append ac_ltlibobjs " \${LIBOBJDIR}$ac_i"'$U.lo' -done -LIB@&t@OBJS=$ac_libobjs - -LTLIBOBJS=$ac_ltlibobjs - - -{ $as_echo "$as_me:${as_lineno-$LINENO}: checking that generated files are newer than configure" >&5 -$as_echo_n "checking that generated files are newer than configure... " >&6; } - if test -n "$am_sleep_pid"; then - # Hide warnings about reused PIDs. - wait $am_sleep_pid 2>/dev/null - fi - { $as_echo "$as_me:${as_lineno-$LINENO}: result: done" >&5 -$as_echo "done" >&6; } - if test -n "$EXEEXT"; then - am__EXEEXT_TRUE= - am__EXEEXT_FALSE='#' -else - am__EXEEXT_TRUE='#' - am__EXEEXT_FALSE= -fi - -if test -z "${AMDEP_TRUE}" && test -z "${AMDEP_FALSE}"; then - as_fn_error $? "conditional \"AMDEP\" was never defined. -Usually this means the macro was only invoked conditionally." "$LINENO" 5 -fi -if test -z "${am__fastdepCC_TRUE}" && test -z "${am__fastdepCC_FALSE}"; then - as_fn_error $? "conditional \"am__fastdepCC\" was never defined. -Usually this means the macro was only invoked conditionally." "$LINENO" 5 -fi -if test -z "${am__fastdepCXX_TRUE}" && test -z "${am__fastdepCXX_FALSE}"; then - as_fn_error $? "conditional \"am__fastdepCXX\" was never defined. -Usually this means the macro was only invoked conditionally." "$LINENO" 5 -fi -case $FC_MODINC in #( - *\ ) FC_MODINC=$FC_MODINC'${ac_empty}' ;; -esac -case $FC_MODOUT in #( - *\ ) FC_MODOUT=$FC_MODOUT'${ac_empty}' ;; -esac -if test -z "${BUNDLE_TRUE}" && test -z "${BUNDLE_FALSE}"; then - as_fn_error $? "conditional \"BUNDLE\" was never defined. -Usually this means the macro was only invoked conditionally." "$LINENO" 5 -fi - -: "${CONFIG_STATUS=./config.status}" -ac_write_fail=0 -ac_clean_files_save=$ac_clean_files -ac_clean_files="$ac_clean_files $CONFIG_STATUS" -{ $as_echo "$as_me:${as_lineno-$LINENO}: creating $CONFIG_STATUS" >&5 -$as_echo "$as_me: creating $CONFIG_STATUS" >&6;} -as_write_fail=0 -cat >$CONFIG_STATUS <<_ASEOF || as_write_fail=1 -#! $SHELL -# Generated by $as_me. -# Run this file to recreate the current configuration. -# Compiler output produced by configure, useful for debugging -# configure, is in config.log if it exists. - -debug=false -ac_cs_recheck=false -ac_cs_silent=false - -SHELL=\${CONFIG_SHELL-$SHELL} -export SHELL -_ASEOF -cat >>$CONFIG_STATUS <<\_ASEOF || as_write_fail=1 -## -------------------- ## -## M4sh Initialization. ## -## -------------------- ## - -# Be more Bourne compatible -DUALCASE=1; export DUALCASE # for MKS sh -if test -n "${ZSH_VERSION+set}" && (emulate sh) >/dev/null 2>&1; then : - emulate sh - NULLCMD=: - # Pre-4.2 versions of Zsh do word splitting on ${1+"$@"}, which - # is contrary to our usage. Disable this feature. - alias -g '${1+"$@"}'='"$@"' - setopt NO_GLOB_SUBST -else - case `(set -o) 2>/dev/null` in @%:@( - *posix*) : - set -o posix ;; @%:@( - *) : - ;; -esac -fi - - -as_nl=' -' -export as_nl -# Printing a long string crashes Solaris 7 /usr/bin/printf. -as_echo='\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\' -as_echo=$as_echo$as_echo$as_echo$as_echo$as_echo -as_echo=$as_echo$as_echo$as_echo$as_echo$as_echo$as_echo -# Prefer a ksh shell builtin over an external printf program on Solaris, -# but without wasting forks for bash or zsh. -if test -z "$BASH_VERSION$ZSH_VERSION" \ - && (test "X`print -r -- $as_echo`" = "X$as_echo") 2>/dev/null; then - as_echo='print -r --' - as_echo_n='print -rn --' -elif (test "X`printf %s $as_echo`" = "X$as_echo") 2>/dev/null; then - as_echo='printf %s\n' - as_echo_n='printf %s' -else - if test "X`(/usr/ucb/echo -n -n $as_echo) 2>/dev/null`" = "X-n $as_echo"; then - as_echo_body='eval /usr/ucb/echo -n "$1$as_nl"' - as_echo_n='/usr/ucb/echo -n' - else - as_echo_body='eval expr "X$1" : "X\\(.*\\)"' - as_echo_n_body='eval - arg=$1; - case $arg in @%:@( - *"$as_nl"*) - expr "X$arg" : "X\\(.*\\)$as_nl"; - arg=`expr "X$arg" : ".*$as_nl\\(.*\\)"`;; - esac; - expr "X$arg" : "X\\(.*\\)" | tr -d "$as_nl" - ' - export as_echo_n_body - as_echo_n='sh -c $as_echo_n_body as_echo' - fi - export as_echo_body - as_echo='sh -c $as_echo_body as_echo' -fi - -# The user is always right. -if test "${PATH_SEPARATOR+set}" != set; then - PATH_SEPARATOR=: - (PATH='/bin;/bin'; FPATH=$PATH; sh -c :) >/dev/null 2>&1 && { - (PATH='/bin:/bin'; FPATH=$PATH; sh -c :) >/dev/null 2>&1 || - PATH_SEPARATOR=';' - } -fi - - -# IFS -# We need space, tab and new line, in precisely that order. Quoting is -# there to prevent editors from complaining about space-tab. -# (If _AS_PATH_WALK were called with IFS unset, it would disable word -# splitting by setting IFS to empty value.) -IFS=" "" $as_nl" - -# Find who we are. Look in the path if we contain no directory separator. -as_myself= -case $0 in @%:@(( - *[\\/]* ) as_myself=$0 ;; - *) as_save_IFS=$IFS; IFS=$PATH_SEPARATOR -for as_dir in $PATH -do - IFS=$as_save_IFS - test -z "$as_dir" && as_dir=. - test -r "$as_dir/$0" && as_myself=$as_dir/$0 && break - done -IFS=$as_save_IFS - - ;; -esac -# We did not find ourselves, most probably we were run as `sh COMMAND' -# in which case we are not to be found in the path. -if test "x$as_myself" = x; then - as_myself=$0 -fi -if test ! -f "$as_myself"; then - $as_echo "$as_myself: error: cannot find myself; rerun with an absolute file name" >&2 - exit 1 -fi - -# Unset variables that we do not need and which cause bugs (e.g. in -# pre-3.0 UWIN ksh). But do not cause bugs in bash 2.01; the "|| exit 1" -# suppresses any "Segmentation fault" message there. '((' could -# trigger a bug in pdksh 5.2.14. -for as_var in BASH_ENV ENV MAIL MAILPATH -do eval test x\${$as_var+set} = xset \ - && ( (unset $as_var) || exit 1) >/dev/null 2>&1 && unset $as_var || : -done -PS1='$ ' -PS2='> ' -PS4='+ ' - -# NLS nuisances. -LC_ALL=C -export LC_ALL -LANGUAGE=C -export LANGUAGE - -# CDPATH. -(unset CDPATH) >/dev/null 2>&1 && unset CDPATH - - -@%:@ as_fn_error STATUS ERROR [LINENO LOG_FD] -@%:@ ---------------------------------------- -@%:@ Output "`basename @S|@0`: error: ERROR" to stderr. If LINENO and LOG_FD are -@%:@ provided, also output the error to LOG_FD, referencing LINENO. Then exit the -@%:@ script with STATUS, using 1 if that was 0. -as_fn_error () -{ - as_status=$1; test $as_status -eq 0 && as_status=1 - if test "$4"; then - as_lineno=${as_lineno-"$3"} as_lineno_stack=as_lineno_stack=$as_lineno_stack - $as_echo "$as_me:${as_lineno-$LINENO}: error: $2" >&$4 - fi - $as_echo "$as_me: error: $2" >&2 - as_fn_exit $as_status -} @%:@ as_fn_error - - -@%:@ as_fn_set_status STATUS -@%:@ ----------------------- -@%:@ Set @S|@? to STATUS, without forking. -as_fn_set_status () -{ - return $1 -} @%:@ as_fn_set_status - -@%:@ as_fn_exit STATUS -@%:@ ----------------- -@%:@ Exit the shell with STATUS, even in a "trap 0" or "set -e" context. -as_fn_exit () -{ - set +e - as_fn_set_status $1 - exit $1 -} @%:@ as_fn_exit - -@%:@ as_fn_unset VAR -@%:@ --------------- -@%:@ Portably unset VAR. -as_fn_unset () -{ - { eval $1=; unset $1;} -} -as_unset=as_fn_unset -@%:@ as_fn_append VAR VALUE -@%:@ ---------------------- -@%:@ Append the text in VALUE to the end of the definition contained in VAR. Take -@%:@ advantage of any shell optimizations that allow amortized linear growth over -@%:@ repeated appends, instead of the typical quadratic growth present in naive -@%:@ implementations. -if (eval "as_var=1; as_var+=2; test x\$as_var = x12") 2>/dev/null; then : - eval 'as_fn_append () - { - eval $1+=\$2 - }' -else - as_fn_append () - { - eval $1=\$$1\$2 - } -fi # as_fn_append - -@%:@ as_fn_arith ARG... -@%:@ ------------------ -@%:@ Perform arithmetic evaluation on the ARGs, and store the result in the -@%:@ global @S|@as_val. Take advantage of shells that can avoid forks. The arguments -@%:@ must be portable across @S|@(()) and expr. -if (eval "test \$(( 1 + 1 )) = 2") 2>/dev/null; then : - eval 'as_fn_arith () - { - as_val=$(( $* )) - }' -else - as_fn_arith () - { - as_val=`expr "$@" || test $? -eq 1` - } -fi # as_fn_arith - - -if expr a : '\(a\)' >/dev/null 2>&1 && - test "X`expr 00001 : '.*\(...\)'`" = X001; then - as_expr=expr -else - as_expr=false -fi - -if (basename -- /) >/dev/null 2>&1 && test "X`basename -- / 2>&1`" = "X/"; then - as_basename=basename -else - as_basename=false -fi - -if (as_dir=`dirname -- /` && test "X$as_dir" = X/) >/dev/null 2>&1; then - as_dirname=dirname -else - as_dirname=false -fi - -as_me=`$as_basename -- "$0" || -$as_expr X/"$0" : '.*/\([^/][^/]*\)/*$' \| \ - X"$0" : 'X\(//\)$' \| \ - X"$0" : 'X\(/\)' \| . 2>/dev/null || -$as_echo X/"$0" | - sed '/^.*\/\([^/][^/]*\)\/*$/{ - s//\1/ - q - } - /^X\/\(\/\/\)$/{ - s//\1/ - q - } - /^X\/\(\/\).*/{ - s//\1/ - q - } - s/.*/./; q'` - -# Avoid depending upon Character Ranges. -as_cr_letters='abcdefghijklmnopqrstuvwxyz' -as_cr_LETTERS='ABCDEFGHIJKLMNOPQRSTUVWXYZ' -as_cr_Letters=$as_cr_letters$as_cr_LETTERS -as_cr_digits='0123456789' -as_cr_alnum=$as_cr_Letters$as_cr_digits - -ECHO_C= ECHO_N= ECHO_T= -case `echo -n x` in @%:@((((( --n*) - case `echo 'xy\c'` in - *c*) ECHO_T=' ';; # ECHO_T is single tab character. - xy) ECHO_C='\c';; - *) echo `echo ksh88 bug on AIX 6.1` > /dev/null - ECHO_T=' ';; - esac;; -*) - ECHO_N='-n';; -esac - -rm -f conf$$ conf$$.exe conf$$.file -if test -d conf$$.dir; then - rm -f conf$$.dir/conf$$.file -else - rm -f conf$$.dir - mkdir conf$$.dir 2>/dev/null -fi -if (echo >conf$$.file) 2>/dev/null; then - if ln -s conf$$.file conf$$ 2>/dev/null; then - as_ln_s='ln -s' - # ... but there are two gotchas: - # 1) On MSYS, both `ln -s file dir' and `ln file dir' fail. - # 2) DJGPP < 2.04 has no symlinks; `ln -s' creates a wrapper executable. - # In both cases, we have to default to `cp -pR'. - ln -s conf$$.file conf$$.dir 2>/dev/null && test ! -f conf$$.exe || - as_ln_s='cp -pR' - elif ln conf$$.file conf$$ 2>/dev/null; then - as_ln_s=ln - else - as_ln_s='cp -pR' - fi -else - as_ln_s='cp -pR' -fi -rm -f conf$$ conf$$.exe conf$$.dir/conf$$.file conf$$.file -rmdir conf$$.dir 2>/dev/null - - -@%:@ as_fn_mkdir_p -@%:@ ------------- -@%:@ Create "@S|@as_dir" as a directory, including parents if necessary. -as_fn_mkdir_p () -{ - - case $as_dir in #( - -*) as_dir=./$as_dir;; - esac - test -d "$as_dir" || eval $as_mkdir_p || { - as_dirs= - while :; do - case $as_dir in #( - *\'*) as_qdir=`$as_echo "$as_dir" | sed "s/'/'\\\\\\\\''/g"`;; #'( - *) as_qdir=$as_dir;; - esac - as_dirs="'$as_qdir' $as_dirs" - as_dir=`$as_dirname -- "$as_dir" || -$as_expr X"$as_dir" : 'X\(.*[^/]\)//*[^/][^/]*/*$' \| \ - X"$as_dir" : 'X\(//\)[^/]' \| \ - X"$as_dir" : 'X\(//\)$' \| \ - X"$as_dir" : 'X\(/\)' \| . 2>/dev/null || -$as_echo X"$as_dir" | - sed '/^X\(.*[^/]\)\/\/*[^/][^/]*\/*$/{ - s//\1/ - q - } - /^X\(\/\/\)[^/].*/{ - s//\1/ - q - } - /^X\(\/\/\)$/{ - s//\1/ - q - } - /^X\(\/\).*/{ - s//\1/ - q - } - s/.*/./; q'` - test -d "$as_dir" && break - done - test -z "$as_dirs" || eval "mkdir $as_dirs" - } || test -d "$as_dir" || as_fn_error $? "cannot create directory $as_dir" - - -} @%:@ as_fn_mkdir_p -if mkdir -p . 2>/dev/null; then - as_mkdir_p='mkdir -p "$as_dir"' -else - test -d ./-p && rmdir ./-p - as_mkdir_p=false -fi - - -@%:@ as_fn_executable_p FILE -@%:@ ----------------------- -@%:@ Test if FILE is an executable regular file. -as_fn_executable_p () -{ - test -f "$1" && test -x "$1" -} @%:@ as_fn_executable_p -as_test_x='test -x' -as_executable_p=as_fn_executable_p - -# Sed expression to map a string onto a valid CPP name. -as_tr_cpp="eval sed 'y%*$as_cr_letters%P$as_cr_LETTERS%;s%[^_$as_cr_alnum]%_%g'" - -# Sed expression to map a string onto a valid variable name. -as_tr_sh="eval sed 'y%*+%pp%;s%[^_$as_cr_alnum]%_%g'" - - -exec 6>&1 -## ----------------------------------- ## -## Main body of $CONFIG_STATUS script. ## -## ----------------------------------- ## -_ASEOF -test $as_write_fail = 0 && chmod +x $CONFIG_STATUS || ac_write_fail=1 - -cat >>$CONFIG_STATUS <<\_ACEOF || ac_write_fail=1 -# Save the log message, to keep $0 and so on meaningful, and to -# report actual input values of CONFIG_FILES etc. instead of their -# values after options handling. -ac_log=" -This file was extended by Munipack $as_me 0.5.9, which was -generated by GNU Autoconf 2.69. Invocation command line was - - CONFIG_FILES = $CONFIG_FILES - CONFIG_HEADERS = $CONFIG_HEADERS - CONFIG_LINKS = $CONFIG_LINKS - CONFIG_COMMANDS = $CONFIG_COMMANDS - $ $0 $@ - -on `(hostname || uname -n) 2>/dev/null | sed 1q` -" - -_ACEOF - -case $ac_config_files in *" -"*) set x $ac_config_files; shift; ac_config_files=$*;; -esac - -case $ac_config_headers in *" -"*) set x $ac_config_headers; shift; ac_config_headers=$*;; -esac - - -cat >>$CONFIG_STATUS <<_ACEOF || ac_write_fail=1 -# Files that config.status was made for. -config_files="$ac_config_files" -config_headers="$ac_config_headers" -config_commands="$ac_config_commands" - -_ACEOF - -cat >>$CONFIG_STATUS <<\_ACEOF || ac_write_fail=1 -ac_cs_usage="\ -\`$as_me' instantiates files and other configuration actions -from templates according to the current configuration. Unless the files -and actions are specified as TAGs, all are instantiated by default. - -Usage: $0 [OPTION]... [TAG]... - - -h, --help print this help, then exit - -V, --version print version number and configuration settings, then exit - --config print configuration, then exit - -q, --quiet, --silent - do not print progress messages - -d, --debug don't remove temporary files - --recheck update $as_me by reconfiguring in the same conditions - --file=FILE[:TEMPLATE] - instantiate the configuration file FILE - --header=FILE[:TEMPLATE] - instantiate the configuration header FILE - -Configuration files: -$config_files - -Configuration headers: -$config_headers - -Configuration commands: -$config_commands - -Report bugs to >. -Munipack home page: ." - -_ACEOF -cat >>$CONFIG_STATUS <<_ACEOF || ac_write_fail=1 -ac_cs_config="`$as_echo "$ac_configure_args" | sed 's/^ //; s/[\\""\`\$]/\\\\&/g'`" -ac_cs_version="\\ -Munipack config.status 0.5.9 -configured by $0, generated by GNU Autoconf 2.69, - with options \\"\$ac_cs_config\\" - -Copyright (C) 2012 Free Software Foundation, Inc. -This config.status script is free software; the Free Software Foundation -gives unlimited permission to copy, distribute and modify it." - -ac_pwd='$ac_pwd' -srcdir='$srcdir' -INSTALL='$INSTALL' -MKDIR_P='$MKDIR_P' -AWK='$AWK' -test -n "\$AWK" || AWK=awk -_ACEOF - -cat >>$CONFIG_STATUS <<\_ACEOF || ac_write_fail=1 -# The default lists apply if the user does not specify any file. -ac_need_defaults=: -while test $# != 0 -do - case $1 in - --*=?*) - ac_option=`expr "X$1" : 'X\([^=]*\)='` - ac_optarg=`expr "X$1" : 'X[^=]*=\(.*\)'` - ac_shift=: - ;; - --*=) - ac_option=`expr "X$1" : 'X\([^=]*\)='` - ac_optarg= - ac_shift=: - ;; - *) - ac_option=$1 - ac_optarg=$2 - ac_shift=shift - ;; - esac - - case $ac_option in - # Handling of the options. - -recheck | --recheck | --rechec | --reche | --rech | --rec | --re | --r) - ac_cs_recheck=: ;; - --version | --versio | --versi | --vers | --ver | --ve | --v | -V ) - $as_echo "$ac_cs_version"; exit ;; - --config | --confi | --conf | --con | --co | --c ) - $as_echo "$ac_cs_config"; exit ;; - --debug | --debu | --deb | --de | --d | -d ) - debug=: ;; - --file | --fil | --fi | --f ) - $ac_shift - case $ac_optarg in - *\'*) ac_optarg=`$as_echo "$ac_optarg" | sed "s/'/'\\\\\\\\''/g"` ;; - '') as_fn_error $? "missing file argument" ;; - esac - as_fn_append CONFIG_FILES " '$ac_optarg'" - ac_need_defaults=false;; - --header | --heade | --head | --hea ) - $ac_shift - case $ac_optarg in - *\'*) ac_optarg=`$as_echo "$ac_optarg" | sed "s/'/'\\\\\\\\''/g"` ;; - esac - as_fn_append CONFIG_HEADERS " '$ac_optarg'" - ac_need_defaults=false;; - --he | --h) - # Conflict between --help and --header - as_fn_error $? "ambiguous option: \`$1' -Try \`$0 --help' for more information.";; - --help | --hel | -h ) - $as_echo "$ac_cs_usage"; exit ;; - -q | -quiet | --quiet | --quie | --qui | --qu | --q \ - | -silent | --silent | --silen | --sile | --sil | --si | --s) - ac_cs_silent=: ;; - - # This is an error. - -*) as_fn_error $? "unrecognized option: \`$1' -Try \`$0 --help' for more information." ;; - - *) as_fn_append ac_config_targets " $1" - ac_need_defaults=false ;; - - esac - shift -done - -ac_configure_extra_args= - -if $ac_cs_silent; then - exec 6>/dev/null - ac_configure_extra_args="$ac_configure_extra_args --silent" -fi - -_ACEOF -cat >>$CONFIG_STATUS <<_ACEOF || ac_write_fail=1 -if \$ac_cs_recheck; then - set X $SHELL '$0' $ac_configure_args \$ac_configure_extra_args --no-create --no-recursion - shift - \$as_echo "running CONFIG_SHELL=$SHELL \$*" >&6 - CONFIG_SHELL='$SHELL' - export CONFIG_SHELL - exec "\$@" -fi - -_ACEOF -cat >>$CONFIG_STATUS <<\_ACEOF || ac_write_fail=1 -exec 5>>config.log -{ - echo - sed 'h;s/./-/g;s/^.../@%:@@%:@ /;s/...$/ @%:@@%:@/;p;x;p;x' <<_ASBOX -@%:@@%:@ Running $as_me. @%:@@%:@ -_ASBOX - $as_echo "$ac_log" -} >&5 - -_ACEOF -cat >>$CONFIG_STATUS <<_ACEOF || ac_write_fail=1 -# -# INIT-COMMANDS -# -AMDEP_TRUE="$AMDEP_TRUE" ac_aux_dir="$ac_aux_dir" - -_ACEOF - -cat >>$CONFIG_STATUS <<\_ACEOF || ac_write_fail=1 - -# Handling of arguments. -for ac_config_target in $ac_config_targets -do - case $ac_config_target in - "depfiles") CONFIG_COMMANDS="$CONFIG_COMMANDS depfiles" ;; - "config.h") CONFIG_HEADERS="$CONFIG_HEADERS config.h" ;; - "minpack/Makefile") CONFIG_FILES="$CONFIG_FILES minpack/Makefile" ;; - "lib/Makefile") CONFIG_FILES="$CONFIG_FILES lib/Makefile" ;; - "preprocess/Makefile") CONFIG_FILES="$CONFIG_FILES preprocess/Makefile" ;; - "kombine/Makefile") CONFIG_FILES="$CONFIG_FILES kombine/Makefile" ;; - "photometry/Makefile") CONFIG_FILES="$CONFIG_FILES photometry/Makefile" ;; - "artificial/Makefile") CONFIG_FILES="$CONFIG_FILES artificial/Makefile" ;; - "fitsut/Makefile") CONFIG_FILES="$CONFIG_FILES fitsut/Makefile" ;; - "list/Makefile") CONFIG_FILES="$CONFIG_FILES list/Makefile" ;; - "astrometry/Makefile") CONFIG_FILES="$CONFIG_FILES astrometry/Makefile" ;; - "coloring/Makefile") CONFIG_FILES="$CONFIG_FILES coloring/Makefile" ;; - "vo/Makefile") CONFIG_FILES="$CONFIG_FILES vo/Makefile" ;; - "munipack/Makefile") CONFIG_FILES="$CONFIG_FILES munipack/Makefile" ;; - "wxMathPlot/Makefile") CONFIG_FILES="$CONFIG_FILES wxMathPlot/Makefile" ;; - "xmunipack/Makefile") CONFIG_FILES="$CONFIG_FILES xmunipack/Makefile" ;; - "doc/Makefile") CONFIG_FILES="$CONFIG_FILES doc/Makefile" ;; - "Makefile") CONFIG_FILES="$CONFIG_FILES Makefile" ;; - - *) as_fn_error $? "invalid argument: \`$ac_config_target'" "$LINENO" 5;; - esac -done - - -# If the user did not use the arguments to specify the items to instantiate, -# then the envvar interface is used. Set only those that are not. -# We use the long form for the default assignment because of an extremely -# bizarre bug on SunOS 4.1.3. -if $ac_need_defaults; then - test "${CONFIG_FILES+set}" = set || CONFIG_FILES=$config_files - test "${CONFIG_HEADERS+set}" = set || CONFIG_HEADERS=$config_headers - test "${CONFIG_COMMANDS+set}" = set || CONFIG_COMMANDS=$config_commands -fi - -# Have a temporary directory for convenience. Make it in the build tree -# simply because there is no reason against having it here, and in addition, -# creating and moving files from /tmp can sometimes cause problems. -# Hook for its removal unless debugging. -# Note that there is a small window in which the directory will not be cleaned: -# after its creation but before its name has been assigned to `$tmp'. -$debug || -{ - tmp= ac_tmp= - trap 'exit_status=$? - : "${ac_tmp:=$tmp}" - { test ! -d "$ac_tmp" || rm -fr "$ac_tmp"; } && exit $exit_status -' 0 - trap 'as_fn_exit 1' 1 2 13 15 -} -# Create a (secure) tmp directory for tmp files. - -{ - tmp=`(umask 077 && mktemp -d "./confXXXXXX") 2>/dev/null` && - test -d "$tmp" -} || -{ - tmp=./conf$$-$RANDOM - (umask 077 && mkdir "$tmp") -} || as_fn_error $? "cannot create a temporary directory in ." "$LINENO" 5 -ac_tmp=$tmp - -# Set up the scripts for CONFIG_FILES section. -# No need to generate them if there are no CONFIG_FILES. -# This happens for instance with `./config.status config.h'. -if test -n "$CONFIG_FILES"; then - - -ac_cr=`echo X | tr X '\015'` -# On cygwin, bash can eat \r inside `` if the user requested igncr. -# But we know of no other shell where ac_cr would be empty at this -# point, so we can use a bashism as a fallback. -if test "x$ac_cr" = x; then - eval ac_cr=\$\'\\r\' -fi -ac_cs_awk_cr=`$AWK 'BEGIN { print "a\rb" }' /dev/null` -if test "$ac_cs_awk_cr" = "a${ac_cr}b"; then - ac_cs_awk_cr='\\r' -else - ac_cs_awk_cr=$ac_cr -fi - -echo 'BEGIN {' >"$ac_tmp/subs1.awk" && -_ACEOF - - -{ - echo "cat >conf$$subs.awk <<_ACEOF" && - echo "$ac_subst_vars" | sed 's/.*/&!$&$ac_delim/' && - echo "_ACEOF" -} >conf$$subs.sh || - as_fn_error $? "could not make $CONFIG_STATUS" "$LINENO" 5 -ac_delim_num=`echo "$ac_subst_vars" | grep -c '^'` -ac_delim='%!_!# ' -for ac_last_try in false false false false false :; do - . ./conf$$subs.sh || - as_fn_error $? "could not make $CONFIG_STATUS" "$LINENO" 5 - - ac_delim_n=`sed -n "s/.*$ac_delim\$/X/p" conf$$subs.awk | grep -c X` - if test $ac_delim_n = $ac_delim_num; then - break - elif $ac_last_try; then - as_fn_error $? "could not make $CONFIG_STATUS" "$LINENO" 5 - else - ac_delim="$ac_delim!$ac_delim _$ac_delim!! " - fi -done -rm -f conf$$subs.sh - -cat >>$CONFIG_STATUS <<_ACEOF || ac_write_fail=1 -cat >>"\$ac_tmp/subs1.awk" <<\\_ACAWK && -_ACEOF -sed -n ' -h -s/^/S["/; s/!.*/"]=/ -p -g -s/^[^!]*!// -:repl -t repl -s/'"$ac_delim"'$// -t delim -:nl -h -s/\(.\{148\}\)..*/\1/ -t more1 -s/["\\]/\\&/g; s/^/"/; s/$/\\n"\\/ -p -n -b repl -:more1 -s/["\\]/\\&/g; s/^/"/; s/$/"\\/ -p -g -s/.\{148\}// -t nl -:delim -h -s/\(.\{148\}\)..*/\1/ -t more2 -s/["\\]/\\&/g; s/^/"/; s/$/"/ -p -b -:more2 -s/["\\]/\\&/g; s/^/"/; s/$/"\\/ -p -g -s/.\{148\}// -t delim -' >$CONFIG_STATUS || ac_write_fail=1 -rm -f conf$$subs.awk -cat >>$CONFIG_STATUS <<_ACEOF || ac_write_fail=1 -_ACAWK -cat >>"\$ac_tmp/subs1.awk" <<_ACAWK && - for (key in S) S_is_set[key] = 1 - FS = "" - -} -{ - line = $ 0 - nfields = split(line, field, "@") - substed = 0 - len = length(field[1]) - for (i = 2; i < nfields; i++) { - key = field[i] - keylen = length(key) - if (S_is_set[key]) { - value = S[key] - line = substr(line, 1, len) "" value "" substr(line, len + keylen + 3) - len += length(value) + length(field[++i]) - substed = 1 - } else - len += 1 + keylen - } - - print line -} - -_ACAWK -_ACEOF -cat >>$CONFIG_STATUS <<\_ACEOF || ac_write_fail=1 -if sed "s/$ac_cr//" < /dev/null > /dev/null 2>&1; then - sed "s/$ac_cr\$//; s/$ac_cr/$ac_cs_awk_cr/g" -else - cat -fi < "$ac_tmp/subs1.awk" > "$ac_tmp/subs.awk" \ - || as_fn_error $? "could not setup config files machinery" "$LINENO" 5 -_ACEOF - -# VPATH may cause trouble with some makes, so we remove sole $(srcdir), -# ${srcdir} and @srcdir@ entries from VPATH if srcdir is ".", strip leading and -# trailing colons and then remove the whole line if VPATH becomes empty -# (actually we leave an empty line to preserve line numbers). -if test "x$srcdir" = x.; then - ac_vpsub='/^[ ]*VPATH[ ]*=[ ]*/{ -h -s/// -s/^/:/ -s/[ ]*$/:/ -s/:\$(srcdir):/:/g -s/:\${srcdir}:/:/g -s/:@srcdir@:/:/g -s/^:*// -s/:*$// -x -s/\(=[ ]*\).*/\1/ -G -s/\n// -s/^[^=]*=[ ]*$// -}' -fi - -cat >>$CONFIG_STATUS <<\_ACEOF || ac_write_fail=1 -fi # test -n "$CONFIG_FILES" - -# Set up the scripts for CONFIG_HEADERS section. -# No need to generate them if there are no CONFIG_HEADERS. -# This happens for instance with `./config.status Makefile'. -if test -n "$CONFIG_HEADERS"; then -cat >"$ac_tmp/defines.awk" <<\_ACAWK || -BEGIN { -_ACEOF - -# Transform confdefs.h into an awk script `defines.awk', embedded as -# here-document in config.status, that substitutes the proper values into -# config.h.in to produce config.h. - -# Create a delimiter string that does not exist in confdefs.h, to ease -# handling of long lines. -ac_delim='%!_!# ' -for ac_last_try in false false :; do - ac_tt=`sed -n "/$ac_delim/p" confdefs.h` - if test -z "$ac_tt"; then - break - elif $ac_last_try; then - as_fn_error $? "could not make $CONFIG_HEADERS" "$LINENO" 5 - else - ac_delim="$ac_delim!$ac_delim _$ac_delim!! " - fi -done - -# For the awk script, D is an array of macro values keyed by name, -# likewise P contains macro parameters if any. Preserve backslash -# newline sequences. - -ac_word_re=[_$as_cr_Letters][_$as_cr_alnum]* -sed -n ' -s/.\{148\}/&'"$ac_delim"'/g -t rset -:rset -s/^[ ]*#[ ]*define[ ][ ]*/ / -t def -d -:def -s/\\$// -t bsnl -s/["\\]/\\&/g -s/^ \('"$ac_word_re"'\)\(([^()]*)\)[ ]*\(.*\)/P["\1"]="\2"\ -D["\1"]=" \3"/p -s/^ \('"$ac_word_re"'\)[ ]*\(.*\)/D["\1"]=" \2"/p -d -:bsnl -s/["\\]/\\&/g -s/^ \('"$ac_word_re"'\)\(([^()]*)\)[ ]*\(.*\)/P["\1"]="\2"\ -D["\1"]=" \3\\\\\\n"\\/p -t cont -s/^ \('"$ac_word_re"'\)[ ]*\(.*\)/D["\1"]=" \2\\\\\\n"\\/p -t cont -d -:cont -n -s/.\{148\}/&'"$ac_delim"'/g -t clear -:clear -s/\\$// -t bsnlc -s/["\\]/\\&/g; s/^/"/; s/$/"/p -d -:bsnlc -s/["\\]/\\&/g; s/^/"/; s/$/\\\\\\n"\\/p -b cont -' >$CONFIG_STATUS || ac_write_fail=1 - -cat >>$CONFIG_STATUS <<_ACEOF || ac_write_fail=1 - for (key in D) D_is_set[key] = 1 - FS = "" -} -/^[\t ]*#[\t ]*(define|undef)[\t ]+$ac_word_re([\t (]|\$)/ { - line = \$ 0 - split(line, arg, " ") - if (arg[1] == "#") { - defundef = arg[2] - mac1 = arg[3] - } else { - defundef = substr(arg[1], 2) - mac1 = arg[2] - } - split(mac1, mac2, "(") #) - macro = mac2[1] - prefix = substr(line, 1, index(line, defundef) - 1) - if (D_is_set[macro]) { - # Preserve the white space surrounding the "#". - print prefix "define", macro P[macro] D[macro] - next - } else { - # Replace #undef with comments. This is necessary, for example, - # in the case of _POSIX_SOURCE, which is predefined and required - # on some systems where configure will not decide to define it. - if (defundef == "undef") { - print "/*", prefix defundef, macro, "*/" - next - } - } -} -{ print } -_ACAWK -_ACEOF -cat >>$CONFIG_STATUS <<\_ACEOF || ac_write_fail=1 - as_fn_error $? "could not setup config headers machinery" "$LINENO" 5 -fi # test -n "$CONFIG_HEADERS" - - -eval set X " :F $CONFIG_FILES :H $CONFIG_HEADERS :C $CONFIG_COMMANDS" -shift -for ac_tag -do - case $ac_tag in - :[FHLC]) ac_mode=$ac_tag; continue;; - esac - case $ac_mode$ac_tag in - :[FHL]*:*);; - :L* | :C*:*) as_fn_error $? "invalid tag \`$ac_tag'" "$LINENO" 5;; - :[FH]-) ac_tag=-:-;; - :[FH]*) ac_tag=$ac_tag:$ac_tag.in;; - esac - ac_save_IFS=$IFS - IFS=: - set x $ac_tag - IFS=$ac_save_IFS - shift - ac_file=$1 - shift - - case $ac_mode in - :L) ac_source=$1;; - :[FH]) - ac_file_inputs= - for ac_f - do - case $ac_f in - -) ac_f="$ac_tmp/stdin";; - *) # Look for the file first in the build tree, then in the source tree - # (if the path is not absolute). The absolute path cannot be DOS-style, - # because $ac_f cannot contain `:'. - test -f "$ac_f" || - case $ac_f in - [\\/$]*) false;; - *) test -f "$srcdir/$ac_f" && ac_f="$srcdir/$ac_f";; - esac || - as_fn_error 1 "cannot find input file: \`$ac_f'" "$LINENO" 5;; - esac - case $ac_f in *\'*) ac_f=`$as_echo "$ac_f" | sed "s/'/'\\\\\\\\''/g"`;; esac - as_fn_append ac_file_inputs " '$ac_f'" - done - - # Let's still pretend it is `configure' which instantiates (i.e., don't - # use $as_me), people would be surprised to read: - # /* config.h. Generated by config.status. */ - configure_input='Generated from '` - $as_echo "$*" | sed 's|^[^:]*/||;s|:[^:]*/|, |g' - `' by configure.' - if test x"$ac_file" != x-; then - configure_input="$ac_file. $configure_input" - { $as_echo "$as_me:${as_lineno-$LINENO}: creating $ac_file" >&5 -$as_echo "$as_me: creating $ac_file" >&6;} - fi - # Neutralize special characters interpreted by sed in replacement strings. - case $configure_input in #( - *\&* | *\|* | *\\* ) - ac_sed_conf_input=`$as_echo "$configure_input" | - sed 's/[\\\\&|]/\\\\&/g'`;; #( - *) ac_sed_conf_input=$configure_input;; - esac - - case $ac_tag in - *:-:* | *:-) cat >"$ac_tmp/stdin" \ - || as_fn_error $? "could not create $ac_file" "$LINENO" 5 ;; - esac - ;; - esac - - ac_dir=`$as_dirname -- "$ac_file" || -$as_expr X"$ac_file" : 'X\(.*[^/]\)//*[^/][^/]*/*$' \| \ - X"$ac_file" : 'X\(//\)[^/]' \| \ - X"$ac_file" : 'X\(//\)$' \| \ - X"$ac_file" : 'X\(/\)' \| . 2>/dev/null || -$as_echo X"$ac_file" | - sed '/^X\(.*[^/]\)\/\/*[^/][^/]*\/*$/{ - s//\1/ - q - } - /^X\(\/\/\)[^/].*/{ - s//\1/ - q - } - /^X\(\/\/\)$/{ - s//\1/ - q - } - /^X\(\/\).*/{ - s//\1/ - q - } - s/.*/./; q'` - as_dir="$ac_dir"; as_fn_mkdir_p - ac_builddir=. - -case "$ac_dir" in -.) ac_dir_suffix= ac_top_builddir_sub=. ac_top_build_prefix= ;; -*) - ac_dir_suffix=/`$as_echo "$ac_dir" | sed 's|^\.[\\/]||'` - # A ".." for each directory in $ac_dir_suffix. - ac_top_builddir_sub=`$as_echo "$ac_dir_suffix" | sed 's|/[^\\/]*|/..|g;s|/||'` - case $ac_top_builddir_sub in - "") ac_top_builddir_sub=. ac_top_build_prefix= ;; - *) ac_top_build_prefix=$ac_top_builddir_sub/ ;; - esac ;; -esac -ac_abs_top_builddir=$ac_pwd -ac_abs_builddir=$ac_pwd$ac_dir_suffix -# for backward compatibility: -ac_top_builddir=$ac_top_build_prefix - -case $srcdir in - .) # We are building in place. - ac_srcdir=. - ac_top_srcdir=$ac_top_builddir_sub - ac_abs_top_srcdir=$ac_pwd ;; - [\\/]* | ?:[\\/]* ) # Absolute name. - ac_srcdir=$srcdir$ac_dir_suffix; - ac_top_srcdir=$srcdir - ac_abs_top_srcdir=$srcdir ;; - *) # Relative name. - ac_srcdir=$ac_top_build_prefix$srcdir$ac_dir_suffix - ac_top_srcdir=$ac_top_build_prefix$srcdir - ac_abs_top_srcdir=$ac_pwd/$srcdir ;; -esac -ac_abs_srcdir=$ac_abs_top_srcdir$ac_dir_suffix - - - case $ac_mode in - :F) - # - # CONFIG_FILE - # - - case $INSTALL in - [\\/$]* | ?:[\\/]* ) ac_INSTALL=$INSTALL ;; - *) ac_INSTALL=$ac_top_build_prefix$INSTALL ;; - esac - ac_MKDIR_P=$MKDIR_P - case $MKDIR_P in - [\\/$]* | ?:[\\/]* ) ;; - */*) ac_MKDIR_P=$ac_top_build_prefix$MKDIR_P ;; - esac -_ACEOF - -cat >>$CONFIG_STATUS <<\_ACEOF || ac_write_fail=1 -# If the template does not know about datarootdir, expand it. -# FIXME: This hack should be removed a few years after 2.60. -ac_datarootdir_hack=; ac_datarootdir_seen= -ac_sed_dataroot=' -/datarootdir/ { - p - q -} -/@datadir@/p -/@docdir@/p -/@infodir@/p -/@localedir@/p -/@mandir@/p' -case `eval "sed -n \"\$ac_sed_dataroot\" $ac_file_inputs"` in -*datarootdir*) ac_datarootdir_seen=yes;; -*@datadir@*|*@docdir@*|*@infodir@*|*@localedir@*|*@mandir@*) - { $as_echo "$as_me:${as_lineno-$LINENO}: WARNING: $ac_file_inputs seems to ignore the --datarootdir setting" >&5 -$as_echo "$as_me: WARNING: $ac_file_inputs seems to ignore the --datarootdir setting" >&2;} -_ACEOF -cat >>$CONFIG_STATUS <<_ACEOF || ac_write_fail=1 - ac_datarootdir_hack=' - s&@datadir@&$datadir&g - s&@docdir@&$docdir&g - s&@infodir@&$infodir&g - s&@localedir@&$localedir&g - s&@mandir@&$mandir&g - s&\\\${datarootdir}&$datarootdir&g' ;; -esac -_ACEOF - -# Neutralize VPATH when `$srcdir' = `.'. -# Shell code in configure.ac might set extrasub. -# FIXME: do we really want to maintain this feature? -cat >>$CONFIG_STATUS <<_ACEOF || ac_write_fail=1 -ac_sed_extra="$ac_vpsub -$extrasub -_ACEOF -cat >>$CONFIG_STATUS <<\_ACEOF || ac_write_fail=1 -:t -/@[a-zA-Z_][a-zA-Z_0-9]*@/!b -s|@configure_input@|$ac_sed_conf_input|;t t -s&@top_builddir@&$ac_top_builddir_sub&;t t -s&@top_build_prefix@&$ac_top_build_prefix&;t t -s&@srcdir@&$ac_srcdir&;t t -s&@abs_srcdir@&$ac_abs_srcdir&;t t -s&@top_srcdir@&$ac_top_srcdir&;t t -s&@abs_top_srcdir@&$ac_abs_top_srcdir&;t t -s&@builddir@&$ac_builddir&;t t -s&@abs_builddir@&$ac_abs_builddir&;t t -s&@abs_top_builddir@&$ac_abs_top_builddir&;t t -s&@INSTALL@&$ac_INSTALL&;t t -s&@MKDIR_P@&$ac_MKDIR_P&;t t -$ac_datarootdir_hack -" -eval sed \"\$ac_sed_extra\" "$ac_file_inputs" | $AWK -f "$ac_tmp/subs.awk" \ - >$ac_tmp/out || as_fn_error $? "could not create $ac_file" "$LINENO" 5 - -test -z "$ac_datarootdir_hack$ac_datarootdir_seen" && - { ac_out=`sed -n '/\${datarootdir}/p' "$ac_tmp/out"`; test -n "$ac_out"; } && - { ac_out=`sed -n '/^[ ]*datarootdir[ ]*:*=/p' \ - "$ac_tmp/out"`; test -z "$ac_out"; } && - { $as_echo "$as_me:${as_lineno-$LINENO}: WARNING: $ac_file contains a reference to the variable \`datarootdir' -which seems to be undefined. Please make sure it is defined" >&5 -$as_echo "$as_me: WARNING: $ac_file contains a reference to the variable \`datarootdir' -which seems to be undefined. Please make sure it is defined" >&2;} - - rm -f "$ac_tmp/stdin" - case $ac_file in - -) cat "$ac_tmp/out" && rm -f "$ac_tmp/out";; - *) rm -f "$ac_file" && mv "$ac_tmp/out" "$ac_file";; - esac \ - || as_fn_error $? "could not create $ac_file" "$LINENO" 5 - ;; - :H) - # - # CONFIG_HEADER - # - if test x"$ac_file" != x-; then - { - $as_echo "/* $configure_input */" \ - && eval '$AWK -f "$ac_tmp/defines.awk"' "$ac_file_inputs" - } >"$ac_tmp/config.h" \ - || as_fn_error $? "could not create $ac_file" "$LINENO" 5 - if diff "$ac_file" "$ac_tmp/config.h" >/dev/null 2>&1; then - { $as_echo "$as_me:${as_lineno-$LINENO}: $ac_file is unchanged" >&5 -$as_echo "$as_me: $ac_file is unchanged" >&6;} - else - rm -f "$ac_file" - mv "$ac_tmp/config.h" "$ac_file" \ - || as_fn_error $? "could not create $ac_file" "$LINENO" 5 - fi - else - $as_echo "/* $configure_input */" \ - && eval '$AWK -f "$ac_tmp/defines.awk"' "$ac_file_inputs" \ - || as_fn_error $? "could not create -" "$LINENO" 5 - fi -# Compute "$ac_file"'s index in $config_headers. -_am_arg="$ac_file" -_am_stamp_count=1 -for _am_header in $config_headers :; do - case $_am_header in - $_am_arg | $_am_arg:* ) - break ;; - * ) - _am_stamp_count=`expr $_am_stamp_count + 1` ;; - esac -done -echo "timestamp for $_am_arg" >`$as_dirname -- "$_am_arg" || -$as_expr X"$_am_arg" : 'X\(.*[^/]\)//*[^/][^/]*/*$' \| \ - X"$_am_arg" : 'X\(//\)[^/]' \| \ - X"$_am_arg" : 'X\(//\)$' \| \ - X"$_am_arg" : 'X\(/\)' \| . 2>/dev/null || -$as_echo X"$_am_arg" | - sed '/^X\(.*[^/]\)\/\/*[^/][^/]*\/*$/{ - s//\1/ - q - } - /^X\(\/\/\)[^/].*/{ - s//\1/ - q - } - /^X\(\/\/\)$/{ - s//\1/ - q - } - /^X\(\/\).*/{ - s//\1/ - q - } - s/.*/./; q'`/stamp-h$_am_stamp_count - ;; - - :C) { $as_echo "$as_me:${as_lineno-$LINENO}: executing $ac_file commands" >&5 -$as_echo "$as_me: executing $ac_file commands" >&6;} - ;; - esac - - - case $ac_file$ac_mode in - "depfiles":C) test x"$AMDEP_TRUE" != x"" || { - # Older Autoconf quotes --file arguments for eval, but not when files - # are listed without --file. Let's play safe and only enable the eval - # if we detect the quoting. - case $CONFIG_FILES in - *\'*) eval set x "$CONFIG_FILES" ;; - *) set x $CONFIG_FILES ;; - esac - shift - for mf - do - # Strip MF so we end up with the name of the file. - mf=`echo "$mf" | sed -e 's/:.*$//'` - # Check whether this is an Automake generated Makefile or not. - # We used to match only the files named 'Makefile.in', but - # some people rename them; so instead we look at the file content. - # Grep'ing the first line is not enough: some people post-process - # each Makefile.in and add a new line on top of each file to say so. - # Grep'ing the whole file is not good either: AIX grep has a line - # limit of 2048, but all sed's we know have understand at least 4000. - if sed -n 's,^#.*generated by automake.*,X,p' "$mf" | grep X >/dev/null 2>&1; then - dirpart=`$as_dirname -- "$mf" || -$as_expr X"$mf" : 'X\(.*[^/]\)//*[^/][^/]*/*$' \| \ - X"$mf" : 'X\(//\)[^/]' \| \ - X"$mf" : 'X\(//\)$' \| \ - X"$mf" : 'X\(/\)' \| . 2>/dev/null || -$as_echo X"$mf" | - sed '/^X\(.*[^/]\)\/\/*[^/][^/]*\/*$/{ - s//\1/ - q - } - /^X\(\/\/\)[^/].*/{ - s//\1/ - q - } - /^X\(\/\/\)$/{ - s//\1/ - q - } - /^X\(\/\).*/{ - s//\1/ - q - } - s/.*/./; q'` - else - continue - fi - # Extract the definition of DEPDIR, am__include, and am__quote - # from the Makefile without running 'make'. - DEPDIR=`sed -n 's/^DEPDIR = //p' < "$mf"` - test -z "$DEPDIR" && continue - am__include=`sed -n 's/^am__include = //p' < "$mf"` - test -z "$am__include" && continue - am__quote=`sed -n 's/^am__quote = //p' < "$mf"` - # Find all dependency output files, they are included files with - # $(DEPDIR) in their names. We invoke sed twice because it is the - # simplest approach to changing $(DEPDIR) to its actual value in the - # expansion. - for file in `sed -n " - s/^$am__include $am__quote\(.*(DEPDIR).*\)$am__quote"'$/\1/p' <"$mf" | \ - sed -e 's/\$(DEPDIR)/'"$DEPDIR"'/g'`; do - # Make sure the directory exists. - test -f "$dirpart/$file" && continue - fdir=`$as_dirname -- "$file" || -$as_expr X"$file" : 'X\(.*[^/]\)//*[^/][^/]*/*$' \| \ - X"$file" : 'X\(//\)[^/]' \| \ - X"$file" : 'X\(//\)$' \| \ - X"$file" : 'X\(/\)' \| . 2>/dev/null || -$as_echo X"$file" | - sed '/^X\(.*[^/]\)\/\/*[^/][^/]*\/*$/{ - s//\1/ - q - } - /^X\(\/\/\)[^/].*/{ - s//\1/ - q - } - /^X\(\/\/\)$/{ - s//\1/ - q - } - /^X\(\/\).*/{ - s//\1/ - q - } - s/.*/./; q'` - as_dir=$dirpart/$fdir; as_fn_mkdir_p - # echo "creating $dirpart/$file" - echo '# dummy' > "$dirpart/$file" - done - done -} - ;; - - esac -done # for ac_tag - - -as_fn_exit 0 -_ACEOF -ac_clean_files=$ac_clean_files_save - -test $ac_write_fail = 0 || - as_fn_error $? "write failure creating $CONFIG_STATUS" "$LINENO" 5 - - -# configure is writing to config.log, and then calls config.status. -# config.status does its own redirection, appending to config.log. -# Unfortunately, on DOS this fails, as config.log is still kept open -# by configure, so config.status won't be able to write to it; its -# output is simply discarded. So we exec the FD to /dev/null, -# effectively closing config.log, so it can be properly (re)opened and -# appended to by config.status. When coming back to configure, we -# need to make the FD available again. -if test "$no_create" != yes; then - ac_cs_success=: - ac_config_status_args= - test "$silent" = yes && - ac_config_status_args="$ac_config_status_args --quiet" - exec 5>/dev/null - $SHELL $CONFIG_STATUS $ac_config_status_args || ac_cs_success=false - exec 5>>config.log - # Use ||, not &&, to avoid exiting from the if with $? = 1, which - # would make configure fail if this is the last instruction. - $ac_cs_success || as_fn_exit 1 -fi -if test -n "$ac_unrecognized_opts" && test "$enable_option_checking" != no; then - { $as_echo "$as_me:${as_lineno-$LINENO}: WARNING: unrecognized options: $ac_unrecognized_opts" >&5 -$as_echo "$as_me: WARNING: unrecognized options: $ac_unrecognized_opts" >&2;} -fi - - -echo -echo " Configured Munipack:" -echo -echo " Virtual Observatory support enabled: ${wxVO}" -echo " Command line interface enabled: ${wxCLI}" -echo " Graphical User Interface enabled: ${wxGUI}" -echo " Bundle installation: ${enable_bundle}" -if test "x$enable_bundle" = "xyes"; then -echo " BUNDLEDIR= ${BUNDLEDIR}" -fi -echo diff -Nru munipack-0.5.9/autom4te.cache/output.1 munipack-0.5.10/autom4te.cache/output.1 --- munipack-0.5.9/autom4te.cache/output.1 2017-07-17 23:04:25.000000000 +0000 +++ munipack-0.5.10/autom4te.cache/output.1 1970-01-01 00:00:00.000000000 +0000 @@ -1,7838 +0,0 @@ -@%:@! /bin/sh -@%:@ Guess values for system-dependent variables and create Makefiles. -@%:@ Generated by GNU Autoconf 2.69 for Munipack 0.5.9. -@%:@ -@%:@ Report bugs to >. -@%:@ -@%:@ -@%:@ Copyright (C) 1992-1996, 1998-2012 Free Software Foundation, Inc. -@%:@ -@%:@ -@%:@ This configure script is free software; the Free Software Foundation -@%:@ gives unlimited permission to copy, distribute and modify it. -## -------------------- ## -## M4sh Initialization. ## -## -------------------- ## - -# Be more Bourne compatible -DUALCASE=1; export DUALCASE # for MKS sh -if test -n "${ZSH_VERSION+set}" && (emulate sh) >/dev/null 2>&1; then : - emulate sh - NULLCMD=: - # Pre-4.2 versions of Zsh do word splitting on ${1+"$@"}, which - # is contrary to our usage. Disable this feature. - alias -g '${1+"$@"}'='"$@"' - setopt NO_GLOB_SUBST -else - case `(set -o) 2>/dev/null` in @%:@( - *posix*) : - set -o posix ;; @%:@( - *) : - ;; -esac -fi - - -as_nl=' -' -export as_nl -# Printing a long string crashes Solaris 7 /usr/bin/printf. -as_echo='\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\' -as_echo=$as_echo$as_echo$as_echo$as_echo$as_echo -as_echo=$as_echo$as_echo$as_echo$as_echo$as_echo$as_echo -# Prefer a ksh shell builtin over an external printf program on Solaris, -# but without wasting forks for bash or zsh. -if test -z "$BASH_VERSION$ZSH_VERSION" \ - && (test "X`print -r -- $as_echo`" = "X$as_echo") 2>/dev/null; then - as_echo='print -r --' - as_echo_n='print -rn --' -elif (test "X`printf %s $as_echo`" = "X$as_echo") 2>/dev/null; then - as_echo='printf %s\n' - as_echo_n='printf %s' -else - if test "X`(/usr/ucb/echo -n -n $as_echo) 2>/dev/null`" = "X-n $as_echo"; then - as_echo_body='eval /usr/ucb/echo -n "$1$as_nl"' - as_echo_n='/usr/ucb/echo -n' - else - as_echo_body='eval expr "X$1" : "X\\(.*\\)"' - as_echo_n_body='eval - arg=$1; - case $arg in @%:@( - *"$as_nl"*) - expr "X$arg" : "X\\(.*\\)$as_nl"; - arg=`expr "X$arg" : ".*$as_nl\\(.*\\)"`;; - esac; - expr "X$arg" : "X\\(.*\\)" | tr -d "$as_nl" - ' - export as_echo_n_body - as_echo_n='sh -c $as_echo_n_body as_echo' - fi - export as_echo_body - as_echo='sh -c $as_echo_body as_echo' -fi - -# The user is always right. -if test "${PATH_SEPARATOR+set}" != set; then - PATH_SEPARATOR=: - (PATH='/bin;/bin'; FPATH=$PATH; sh -c :) >/dev/null 2>&1 && { - (PATH='/bin:/bin'; FPATH=$PATH; sh -c :) >/dev/null 2>&1 || - PATH_SEPARATOR=';' - } -fi - - -# IFS -# We need space, tab and new line, in precisely that order. Quoting is -# there to prevent editors from complaining about space-tab. -# (If _AS_PATH_WALK were called with IFS unset, it would disable word -# splitting by setting IFS to empty value.) -IFS=" "" $as_nl" - -# Find who we are. Look in the path if we contain no directory separator. -as_myself= -case $0 in @%:@(( - *[\\/]* ) as_myself=$0 ;; - *) as_save_IFS=$IFS; IFS=$PATH_SEPARATOR -for as_dir in $PATH -do - IFS=$as_save_IFS - test -z "$as_dir" && as_dir=. - test -r "$as_dir/$0" && as_myself=$as_dir/$0 && break - done -IFS=$as_save_IFS - - ;; -esac -# We did not find ourselves, most probably we were run as `sh COMMAND' -# in which case we are not to be found in the path. -if test "x$as_myself" = x; then - as_myself=$0 -fi -if test ! -f "$as_myself"; then - $as_echo "$as_myself: error: cannot find myself; rerun with an absolute file name" >&2 - exit 1 -fi - -# Unset variables that we do not need and which cause bugs (e.g. in -# pre-3.0 UWIN ksh). But do not cause bugs in bash 2.01; the "|| exit 1" -# suppresses any "Segmentation fault" message there. '((' could -# trigger a bug in pdksh 5.2.14. -for as_var in BASH_ENV ENV MAIL MAILPATH -do eval test x\${$as_var+set} = xset \ - && ( (unset $as_var) || exit 1) >/dev/null 2>&1 && unset $as_var || : -done -PS1='$ ' -PS2='> ' -PS4='+ ' - -# NLS nuisances. -LC_ALL=C -export LC_ALL -LANGUAGE=C -export LANGUAGE - -# CDPATH. -(unset CDPATH) >/dev/null 2>&1 && unset CDPATH - -# Use a proper internal environment variable to ensure we don't fall - # into an infinite loop, continuously re-executing ourselves. - if test x"${_as_can_reexec}" != xno && test "x$CONFIG_SHELL" != x; then - _as_can_reexec=no; export _as_can_reexec; - # We cannot yet assume a decent shell, so we have to provide a -# neutralization value for shells without unset; and this also -# works around shells that cannot unset nonexistent variables. -# Preserve -v and -x to the replacement shell. -BASH_ENV=/dev/null -ENV=/dev/null -(unset BASH_ENV) >/dev/null 2>&1 && unset BASH_ENV ENV -case $- in @%:@ (((( - *v*x* | *x*v* ) as_opts=-vx ;; - *v* ) as_opts=-v ;; - *x* ) as_opts=-x ;; - * ) as_opts= ;; -esac -exec $CONFIG_SHELL $as_opts "$as_myself" ${1+"$@"} -# Admittedly, this is quite paranoid, since all the known shells bail -# out after a failed `exec'. -$as_echo "$0: could not re-execute with $CONFIG_SHELL" >&2 -as_fn_exit 255 - fi - # We don't want this to propagate to other subprocesses. - { _as_can_reexec=; unset _as_can_reexec;} -if test "x$CONFIG_SHELL" = x; then - as_bourne_compatible="if test -n \"\${ZSH_VERSION+set}\" && (emulate sh) >/dev/null 2>&1; then : - emulate sh - NULLCMD=: - # Pre-4.2 versions of Zsh do word splitting on \${1+\"\$@\"}, which - # is contrary to our usage. Disable this feature. - alias -g '\${1+\"\$@\"}'='\"\$@\"' - setopt NO_GLOB_SUBST -else - case \`(set -o) 2>/dev/null\` in @%:@( - *posix*) : - set -o posix ;; @%:@( - *) : - ;; -esac -fi -" - as_required="as_fn_return () { (exit \$1); } -as_fn_success () { as_fn_return 0; } -as_fn_failure () { as_fn_return 1; } -as_fn_ret_success () { return 0; } -as_fn_ret_failure () { return 1; } - -exitcode=0 -as_fn_success || { exitcode=1; echo as_fn_success failed.; } -as_fn_failure && { exitcode=1; echo as_fn_failure succeeded.; } -as_fn_ret_success || { exitcode=1; echo as_fn_ret_success failed.; } -as_fn_ret_failure && { exitcode=1; echo as_fn_ret_failure succeeded.; } -if ( set x; as_fn_ret_success y && test x = \"\$1\" ); then : - -else - exitcode=1; echo positional parameters were not saved. -fi -test x\$exitcode = x0 || exit 1 -test -x / || exit 1" - as_suggested=" as_lineno_1=";as_suggested=$as_suggested$LINENO;as_suggested=$as_suggested" as_lineno_1a=\$LINENO - as_lineno_2=";as_suggested=$as_suggested$LINENO;as_suggested=$as_suggested" as_lineno_2a=\$LINENO - eval 'test \"x\$as_lineno_1'\$as_run'\" != \"x\$as_lineno_2'\$as_run'\" && - test \"x\`expr \$as_lineno_1'\$as_run' + 1\`\" = \"x\$as_lineno_2'\$as_run'\"' || exit 1 -test \$(( 1 + 1 )) = 2 || exit 1" - if (eval "$as_required") 2>/dev/null; then : - as_have_required=yes -else - as_have_required=no -fi - if test x$as_have_required = xyes && (eval "$as_suggested") 2>/dev/null; then : - -else - as_save_IFS=$IFS; IFS=$PATH_SEPARATOR -as_found=false -for as_dir in /bin$PATH_SEPARATOR/usr/bin$PATH_SEPARATOR$PATH -do - IFS=$as_save_IFS - test -z "$as_dir" && as_dir=. - as_found=: - case $as_dir in @%:@( - /*) - for as_base in sh bash ksh sh5; do - # Try only shells that exist, to save several forks. - as_shell=$as_dir/$as_base - if { test -f "$as_shell" || test -f "$as_shell.exe"; } && - { $as_echo "$as_bourne_compatible""$as_required" | as_run=a "$as_shell"; } 2>/dev/null; then : - CONFIG_SHELL=$as_shell as_have_required=yes - if { $as_echo "$as_bourne_compatible""$as_suggested" | as_run=a "$as_shell"; } 2>/dev/null; then : - break 2 -fi -fi - done;; - esac - as_found=false -done -$as_found || { if { test -f "$SHELL" || test -f "$SHELL.exe"; } && - { $as_echo "$as_bourne_compatible""$as_required" | as_run=a "$SHELL"; } 2>/dev/null; then : - CONFIG_SHELL=$SHELL as_have_required=yes -fi; } -IFS=$as_save_IFS - - - if test "x$CONFIG_SHELL" != x; then : - export CONFIG_SHELL - # We cannot yet assume a decent shell, so we have to provide a -# neutralization value for shells without unset; and this also -# works around shells that cannot unset nonexistent variables. -# Preserve -v and -x to the replacement shell. -BASH_ENV=/dev/null -ENV=/dev/null -(unset BASH_ENV) >/dev/null 2>&1 && unset BASH_ENV ENV -case $- in @%:@ (((( - *v*x* | *x*v* ) as_opts=-vx ;; - *v* ) as_opts=-v ;; - *x* ) as_opts=-x ;; - * ) as_opts= ;; -esac -exec $CONFIG_SHELL $as_opts "$as_myself" ${1+"$@"} -# Admittedly, this is quite paranoid, since all the known shells bail -# out after a failed `exec'. -$as_echo "$0: could not re-execute with $CONFIG_SHELL" >&2 -exit 255 -fi - - if test x$as_have_required = xno; then : - $as_echo "$0: This script requires a shell more modern than all" - $as_echo "$0: the shells that I found on your system." - if test x${ZSH_VERSION+set} = xset ; then - $as_echo "$0: In particular, zsh $ZSH_VERSION has bugs and should" - $as_echo "$0: be upgraded to zsh 4.3.4 or later." - else - $as_echo "$0: Please tell bug-autoconf@gnu.org and Filip Hroch -$0: about your system, including -$0: any error possibly output before this message. Then -$0: install a modern shell, or manually run the script -$0: under such a shell if you do have one." - fi - exit 1 -fi -fi -fi -SHELL=${CONFIG_SHELL-/bin/sh} -export SHELL -# Unset more variables known to interfere with behavior of common tools. -CLICOLOR_FORCE= GREP_OPTIONS= -unset CLICOLOR_FORCE GREP_OPTIONS - -## --------------------- ## -## M4sh Shell Functions. ## -## --------------------- ## -@%:@ as_fn_unset VAR -@%:@ --------------- -@%:@ Portably unset VAR. -as_fn_unset () -{ - { eval $1=; unset $1;} -} -as_unset=as_fn_unset - -@%:@ as_fn_set_status STATUS -@%:@ ----------------------- -@%:@ Set @S|@? to STATUS, without forking. -as_fn_set_status () -{ - return $1 -} @%:@ as_fn_set_status - -@%:@ as_fn_exit STATUS -@%:@ ----------------- -@%:@ Exit the shell with STATUS, even in a "trap 0" or "set -e" context. -as_fn_exit () -{ - set +e - as_fn_set_status $1 - exit $1 -} @%:@ as_fn_exit - -@%:@ as_fn_mkdir_p -@%:@ ------------- -@%:@ Create "@S|@as_dir" as a directory, including parents if necessary. -as_fn_mkdir_p () -{ - - case $as_dir in #( - -*) as_dir=./$as_dir;; - esac - test -d "$as_dir" || eval $as_mkdir_p || { - as_dirs= - while :; do - case $as_dir in #( - *\'*) as_qdir=`$as_echo "$as_dir" | sed "s/'/'\\\\\\\\''/g"`;; #'( - *) as_qdir=$as_dir;; - esac - as_dirs="'$as_qdir' $as_dirs" - as_dir=`$as_dirname -- "$as_dir" || -$as_expr X"$as_dir" : 'X\(.*[^/]\)//*[^/][^/]*/*$' \| \ - X"$as_dir" : 'X\(//\)[^/]' \| \ - X"$as_dir" : 'X\(//\)$' \| \ - X"$as_dir" : 'X\(/\)' \| . 2>/dev/null || -$as_echo X"$as_dir" | - sed '/^X\(.*[^/]\)\/\/*[^/][^/]*\/*$/{ - s//\1/ - q - } - /^X\(\/\/\)[^/].*/{ - s//\1/ - q - } - /^X\(\/\/\)$/{ - s//\1/ - q - } - /^X\(\/\).*/{ - s//\1/ - q - } - s/.*/./; q'` - test -d "$as_dir" && break - done - test -z "$as_dirs" || eval "mkdir $as_dirs" - } || test -d "$as_dir" || as_fn_error $? "cannot create directory $as_dir" - - -} @%:@ as_fn_mkdir_p - -@%:@ as_fn_executable_p FILE -@%:@ ----------------------- -@%:@ Test if FILE is an executable regular file. -as_fn_executable_p () -{ - test -f "$1" && test -x "$1" -} @%:@ as_fn_executable_p -@%:@ as_fn_append VAR VALUE -@%:@ ---------------------- -@%:@ Append the text in VALUE to the end of the definition contained in VAR. Take -@%:@ advantage of any shell optimizations that allow amortized linear growth over -@%:@ repeated appends, instead of the typical quadratic growth present in naive -@%:@ implementations. -if (eval "as_var=1; as_var+=2; test x\$as_var = x12") 2>/dev/null; then : - eval 'as_fn_append () - { - eval $1+=\$2 - }' -else - as_fn_append () - { - eval $1=\$$1\$2 - } -fi # as_fn_append - -@%:@ as_fn_arith ARG... -@%:@ ------------------ -@%:@ Perform arithmetic evaluation on the ARGs, and store the result in the -@%:@ global @S|@as_val. Take advantage of shells that can avoid forks. The arguments -@%:@ must be portable across @S|@(()) and expr. -if (eval "test \$(( 1 + 1 )) = 2") 2>/dev/null; then : - eval 'as_fn_arith () - { - as_val=$(( $* )) - }' -else - as_fn_arith () - { - as_val=`expr "$@" || test $? -eq 1` - } -fi # as_fn_arith - - -@%:@ as_fn_error STATUS ERROR [LINENO LOG_FD] -@%:@ ---------------------------------------- -@%:@ Output "`basename @S|@0`: error: ERROR" to stderr. If LINENO and LOG_FD are -@%:@ provided, also output the error to LOG_FD, referencing LINENO. Then exit the -@%:@ script with STATUS, using 1 if that was 0. -as_fn_error () -{ - as_status=$1; test $as_status -eq 0 && as_status=1 - if test "$4"; then - as_lineno=${as_lineno-"$3"} as_lineno_stack=as_lineno_stack=$as_lineno_stack - $as_echo "$as_me:${as_lineno-$LINENO}: error: $2" >&$4 - fi - $as_echo "$as_me: error: $2" >&2 - as_fn_exit $as_status -} @%:@ as_fn_error - -if expr a : '\(a\)' >/dev/null 2>&1 && - test "X`expr 00001 : '.*\(...\)'`" = X001; then - as_expr=expr -else - as_expr=false -fi - -if (basename -- /) >/dev/null 2>&1 && test "X`basename -- / 2>&1`" = "X/"; then - as_basename=basename -else - as_basename=false -fi - -if (as_dir=`dirname -- /` && test "X$as_dir" = X/) >/dev/null 2>&1; then - as_dirname=dirname -else - as_dirname=false -fi - -as_me=`$as_basename -- "$0" || -$as_expr X/"$0" : '.*/\([^/][^/]*\)/*$' \| \ - X"$0" : 'X\(//\)$' \| \ - X"$0" : 'X\(/\)' \| . 2>/dev/null || -$as_echo X/"$0" | - sed '/^.*\/\([^/][^/]*\)\/*$/{ - s//\1/ - q - } - /^X\/\(\/\/\)$/{ - s//\1/ - q - } - /^X\/\(\/\).*/{ - s//\1/ - q - } - s/.*/./; q'` - -# Avoid depending upon Character Ranges. -as_cr_letters='abcdefghijklmnopqrstuvwxyz' -as_cr_LETTERS='ABCDEFGHIJKLMNOPQRSTUVWXYZ' -as_cr_Letters=$as_cr_letters$as_cr_LETTERS -as_cr_digits='0123456789' -as_cr_alnum=$as_cr_Letters$as_cr_digits - - - as_lineno_1=$LINENO as_lineno_1a=$LINENO - as_lineno_2=$LINENO as_lineno_2a=$LINENO - eval 'test "x$as_lineno_1'$as_run'" != "x$as_lineno_2'$as_run'" && - test "x`expr $as_lineno_1'$as_run' + 1`" = "x$as_lineno_2'$as_run'"' || { - # Blame Lee E. McMahon (1931-1989) for sed's syntax. :-) - sed -n ' - p - /[$]LINENO/= - ' <$as_myself | - sed ' - s/[$]LINENO.*/&-/ - t lineno - b - :lineno - N - :loop - s/[$]LINENO\([^'$as_cr_alnum'_].*\n\)\(.*\)/\2\1\2/ - t loop - s/-\n.*// - ' >$as_me.lineno && - chmod +x "$as_me.lineno" || - { $as_echo "$as_me: error: cannot create $as_me.lineno; rerun with a POSIX shell" >&2; as_fn_exit 1; } - - # If we had to re-execute with $CONFIG_SHELL, we're ensured to have - # already done that, so ensure we don't try to do so again and fall - # in an infinite loop. This has already happened in practice. - _as_can_reexec=no; export _as_can_reexec - # Don't try to exec as it changes $[0], causing all sort of problems - # (the dirname of $[0] is not the place where we might find the - # original and so on. Autoconf is especially sensitive to this). - . "./$as_me.lineno" - # Exit status is that of the last command. - exit -} - -ECHO_C= ECHO_N= ECHO_T= -case `echo -n x` in @%:@((((( --n*) - case `echo 'xy\c'` in - *c*) ECHO_T=' ';; # ECHO_T is single tab character. - xy) ECHO_C='\c';; - *) echo `echo ksh88 bug on AIX 6.1` > /dev/null - ECHO_T=' ';; - esac;; -*) - ECHO_N='-n';; -esac - -rm -f conf$$ conf$$.exe conf$$.file -if test -d conf$$.dir; then - rm -f conf$$.dir/conf$$.file -else - rm -f conf$$.dir - mkdir conf$$.dir 2>/dev/null -fi -if (echo >conf$$.file) 2>/dev/null; then - if ln -s conf$$.file conf$$ 2>/dev/null; then - as_ln_s='ln -s' - # ... but there are two gotchas: - # 1) On MSYS, both `ln -s file dir' and `ln file dir' fail. - # 2) DJGPP < 2.04 has no symlinks; `ln -s' creates a wrapper executable. - # In both cases, we have to default to `cp -pR'. - ln -s conf$$.file conf$$.dir 2>/dev/null && test ! -f conf$$.exe || - as_ln_s='cp -pR' - elif ln conf$$.file conf$$ 2>/dev/null; then - as_ln_s=ln - else - as_ln_s='cp -pR' - fi -else - as_ln_s='cp -pR' -fi -rm -f conf$$ conf$$.exe conf$$.dir/conf$$.file conf$$.file -rmdir conf$$.dir 2>/dev/null - -if mkdir -p . 2>/dev/null; then - as_mkdir_p='mkdir -p "$as_dir"' -else - test -d ./-p && rmdir ./-p - as_mkdir_p=false -fi - -as_test_x='test -x' -as_executable_p=as_fn_executable_p - -# Sed expression to map a string onto a valid CPP name. -as_tr_cpp="eval sed 'y%*$as_cr_letters%P$as_cr_LETTERS%;s%[^_$as_cr_alnum]%_%g'" - -# Sed expression to map a string onto a valid variable name. -as_tr_sh="eval sed 'y%*+%pp%;s%[^_$as_cr_alnum]%_%g'" - - -test -n "$DJDIR" || exec 7<&0 &1 - -# Name of the host. -# hostname on some systems (SVR3.2, old GNU/Linux) returns a bogus exit status, -# so uname gets run too. -ac_hostname=`(hostname || uname -n) 2>/dev/null | sed 1q` - -# -# Initializations. -# -ac_default_prefix=/usr/local -ac_clean_files= -ac_config_libobj_dir=. -LIB@&t@OBJS= -cross_compiling=no -subdirs= -MFLAGS= -MAKEFLAGS= - -# Identity of this package. -PACKAGE_NAME='Munipack' -PACKAGE_TARNAME='munipack' -PACKAGE_VERSION='0.5.9' -PACKAGE_STRING='Munipack 0.5.9' -PACKAGE_BUGREPORT='Filip Hroch ' -PACKAGE_URL='http://munipack.physics.muni.cz' - -# Factoring default headers for most tests. -ac_includes_default="\ -#include -#ifdef HAVE_SYS_TYPES_H -# include -#endif -#ifdef HAVE_SYS_STAT_H -# include -#endif -#ifdef STDC_HEADERS -# include -# include -#else -# ifdef HAVE_STDLIB_H -# include -# endif -#endif -#ifdef HAVE_STRING_H -# if !defined STDC_HEADERS && defined HAVE_MEMORY_H -# include -# endif -# include -#endif -#ifdef HAVE_STRINGS_H -# include -#endif -#ifdef HAVE_INTTYPES_H -# include -#endif -#ifdef HAVE_STDINT_H -# include -#endif -#ifdef HAVE_UNISTD_H -# include -#endif" - -ac_subst_vars='am__EXEEXT_FALSE -am__EXEEXT_TRUE -LTLIBOBJS -CLEANFILES -LIBSTDCPP -LIBGCC -LIBGFORTRAN -BUNDLEDIR -BUNDLE_FALSE -BUNDLE_TRUE -VODIR -WX_CXXFLAGS_VO -WX_LIBS_VO -WX_LIBS_CLI -WX_CXXFLAGS_CLI -MUNIPACKDIR -MATPLOTDIR -XMUNIPACKDIR -WX_VERSION_MICRO -WX_VERSION_MINOR -WX_VERSION_MAJOR -WX_RESCOMP -WX_VERSION -WX_LIBS_STATIC -WX_LIBS -WX_CXXFLAGS_ONLY -WX_CFLAGS_ONLY -WX_CXXFLAGS -WX_CFLAGS -WX_CPPFLAGS -WX_CONFIG_PATH -LDMINPACK -MINPACKDIR -ac_ct_F77 -FFLAGS -F77 -LIBCFITSIO -FC_MODEXT -FC_MODOUT -ac_empty -FC_MODINC -LIB@&t@OBJS -EGREP -GREP -LN_S -RANLIB -ac_ct_FC -FCFLAGS -FC -CPP -am__fastdepCXX_FALSE -am__fastdepCXX_TRUE -CXXDEPMODE -ac_ct_CXX -CXXFLAGS -CXX -am__fastdepCC_FALSE -am__fastdepCC_TRUE -CCDEPMODE -am__nodep -AMDEPBACKSLASH -AMDEP_FALSE -AMDEP_TRUE -am__quote -am__include -DEPDIR -OBJEXT -EXEEXT -ac_ct_CC -CPPFLAGS -LDFLAGS -CFLAGS -CC -AM_BACKSLASH -AM_DEFAULT_VERBOSITY -AM_DEFAULT_V -AM_V -am__untar -am__tar -AMTAR -am__leading_dot -SET_MAKE -AWK -mkdir_p -MKDIR_P -INSTALL_STRIP_PROGRAM -STRIP -install_sh -MAKEINFO -AUTOHEADER -AUTOMAKE -AUTOCONF -ACLOCAL -VERSION -PACKAGE -CYGPATH_W -am__isrc -INSTALL_DATA -INSTALL_SCRIPT -INSTALL_PROGRAM -build_os -build_vendor -build_cpu -build -develop -target_alias -host_alias -build_alias -LIBS -ECHO_T -ECHO_N -ECHO_C -DEFS -mandir -localedir -libdir -psdir -pdfdir -dvidir -htmldir -infodir -docdir -oldincludedir -includedir -runstatedir -localstatedir -sharedstatedir -sysconfdir -datadir -datarootdir -libexecdir -sbindir -bindir -program_transform_name -prefix -exec_prefix -PACKAGE_URL -PACKAGE_BUGREPORT -PACKAGE_STRING -PACKAGE_VERSION -PACKAGE_TARNAME -PACKAGE_NAME -PATH_SEPARATOR -SHELL' -ac_subst_files='' -ac_user_opts=' -enable_option_checking -enable_silent_rules -enable_dependency_tracking -enable_vo -enable_cli -enable_gui -with_wxdir -with_wx_config -with_wx_prefix -with_wx_exec_prefix -enable_bundle -' - ac_precious_vars='build_alias -host_alias -target_alias -CC -CFLAGS -LDFLAGS -LIBS -CPPFLAGS -CXX -CXXFLAGS -CCC -CPP -FC -FCFLAGS -F77 -FFLAGS -BUNDLEDIR' - - -# Initialize some variables set by options. -ac_init_help= -ac_init_version=false -ac_unrecognized_opts= -ac_unrecognized_sep= -# The variables have the same names as the options, with -# dashes changed to underlines. -cache_file=/dev/null -exec_prefix=NONE -no_create= -no_recursion= -prefix=NONE -program_prefix=NONE -program_suffix=NONE -program_transform_name=s,x,x, -silent= -site= -srcdir= -verbose= -x_includes=NONE -x_libraries=NONE - -# Installation directory options. -# These are left unexpanded so users can "make install exec_prefix=/foo" -# and all the variables that are supposed to be based on exec_prefix -# by default will actually change. -# Use braces instead of parens because sh, perl, etc. also accept them. -# (The list follows the same order as the GNU Coding Standards.) -bindir='${exec_prefix}/bin' -sbindir='${exec_prefix}/sbin' -libexecdir='${exec_prefix}/libexec' -datarootdir='${prefix}/share' -datadir='${datarootdir}' -sysconfdir='${prefix}/etc' -sharedstatedir='${prefix}/com' -localstatedir='${prefix}/var' -runstatedir='${localstatedir}/run' -includedir='${prefix}/include' -oldincludedir='/usr/include' -docdir='${datarootdir}/doc/${PACKAGE_TARNAME}' -infodir='${datarootdir}/info' -htmldir='${docdir}' -dvidir='${docdir}' -pdfdir='${docdir}' -psdir='${docdir}' -libdir='${exec_prefix}/lib' -localedir='${datarootdir}/locale' -mandir='${datarootdir}/man' - -ac_prev= -ac_dashdash= -for ac_option -do - # If the previous option needs an argument, assign it. - if test -n "$ac_prev"; then - eval $ac_prev=\$ac_option - ac_prev= - continue - fi - - case $ac_option in - *=?*) ac_optarg=`expr "X$ac_option" : '[^=]*=\(.*\)'` ;; - *=) ac_optarg= ;; - *) ac_optarg=yes ;; - esac - - # Accept the important Cygnus configure options, so we can diagnose typos. - - case $ac_dashdash$ac_option in - --) - ac_dashdash=yes ;; - - -bindir | --bindir | --bindi | --bind | --bin | --bi) - ac_prev=bindir ;; - -bindir=* | --bindir=* | --bindi=* | --bind=* | --bin=* | --bi=*) - bindir=$ac_optarg ;; - - -build | --build | --buil | --bui | --bu) - ac_prev=build_alias ;; - -build=* | --build=* | --buil=* | --bui=* | --bu=*) - build_alias=$ac_optarg ;; - - -cache-file | --cache-file | --cache-fil | --cache-fi \ - | --cache-f | --cache- | --cache | --cach | --cac | --ca | --c) - ac_prev=cache_file ;; - -cache-file=* | --cache-file=* | --cache-fil=* | --cache-fi=* \ - | --cache-f=* | --cache-=* | --cache=* | --cach=* | --cac=* | --ca=* | --c=*) - cache_file=$ac_optarg ;; - - --config-cache | -C) - cache_file=config.cache ;; - - -datadir | --datadir | --datadi | --datad) - ac_prev=datadir ;; - -datadir=* | --datadir=* | --datadi=* | --datad=*) - datadir=$ac_optarg ;; - - -datarootdir | --datarootdir | --datarootdi | --datarootd | --dataroot \ - | --dataroo | --dataro | --datar) - ac_prev=datarootdir ;; - -datarootdir=* | --datarootdir=* | --datarootdi=* | --datarootd=* \ - | --dataroot=* | --dataroo=* | --dataro=* | --datar=*) - datarootdir=$ac_optarg ;; - - -disable-* | --disable-*) - ac_useropt=`expr "x$ac_option" : 'x-*disable-\(.*\)'` - # Reject names that are not valid shell variable names. - expr "x$ac_useropt" : ".*[^-+._$as_cr_alnum]" >/dev/null && - as_fn_error $? "invalid feature name: $ac_useropt" - ac_useropt_orig=$ac_useropt - ac_useropt=`$as_echo "$ac_useropt" | sed 's/[-+.]/_/g'` - case $ac_user_opts in - *" -"enable_$ac_useropt" -"*) ;; - *) ac_unrecognized_opts="$ac_unrecognized_opts$ac_unrecognized_sep--disable-$ac_useropt_orig" - ac_unrecognized_sep=', ';; - esac - eval enable_$ac_useropt=no ;; - - -docdir | --docdir | --docdi | --doc | --do) - ac_prev=docdir ;; - -docdir=* | --docdir=* | --docdi=* | --doc=* | --do=*) - docdir=$ac_optarg ;; - - -dvidir | --dvidir | --dvidi | --dvid | --dvi | --dv) - ac_prev=dvidir ;; - -dvidir=* | --dvidir=* | --dvidi=* | --dvid=* | --dvi=* | --dv=*) - dvidir=$ac_optarg ;; - - -enable-* | --enable-*) - ac_useropt=`expr "x$ac_option" : 'x-*enable-\([^=]*\)'` - # Reject names that are not valid shell variable names. - expr "x$ac_useropt" : ".*[^-+._$as_cr_alnum]" >/dev/null && - as_fn_error $? "invalid feature name: $ac_useropt" - ac_useropt_orig=$ac_useropt - ac_useropt=`$as_echo "$ac_useropt" | sed 's/[-+.]/_/g'` - case $ac_user_opts in - *" -"enable_$ac_useropt" -"*) ;; - *) ac_unrecognized_opts="$ac_unrecognized_opts$ac_unrecognized_sep--enable-$ac_useropt_orig" - ac_unrecognized_sep=', ';; - esac - eval enable_$ac_useropt=\$ac_optarg ;; - - -exec-prefix | --exec_prefix | --exec-prefix | --exec-prefi \ - | --exec-pref | --exec-pre | --exec-pr | --exec-p | --exec- \ - | --exec | --exe | --ex) - ac_prev=exec_prefix ;; - -exec-prefix=* | --exec_prefix=* | --exec-prefix=* | --exec-prefi=* \ - | --exec-pref=* | --exec-pre=* | --exec-pr=* | --exec-p=* | --exec-=* \ - | --exec=* | --exe=* | --ex=*) - exec_prefix=$ac_optarg ;; - - -gas | --gas | --ga | --g) - # Obsolete; use --with-gas. - with_gas=yes ;; - - -help | --help | --hel | --he | -h) - ac_init_help=long ;; - -help=r* | --help=r* | --hel=r* | --he=r* | -hr*) - ac_init_help=recursive ;; - -help=s* | --help=s* | --hel=s* | --he=s* | -hs*) - ac_init_help=short ;; - - -host | --host | --hos | --ho) - ac_prev=host_alias ;; - -host=* | --host=* | --hos=* | --ho=*) - host_alias=$ac_optarg ;; - - -htmldir | --htmldir | --htmldi | --htmld | --html | --htm | --ht) - ac_prev=htmldir ;; - -htmldir=* | --htmldir=* | --htmldi=* | --htmld=* | --html=* | --htm=* \ - | --ht=*) - htmldir=$ac_optarg ;; - - -includedir | --includedir | --includedi | --included | --include \ - | --includ | --inclu | --incl | --inc) - ac_prev=includedir ;; - -includedir=* | --includedir=* | --includedi=* | --included=* | --include=* \ - | --includ=* | --inclu=* | --incl=* | --inc=*) - includedir=$ac_optarg ;; - - -infodir | --infodir | --infodi | --infod | --info | --inf) - ac_prev=infodir ;; - -infodir=* | --infodir=* | --infodi=* | --infod=* | --info=* | --inf=*) - infodir=$ac_optarg ;; - - -libdir | --libdir | --libdi | --libd) - ac_prev=libdir ;; - -libdir=* | --libdir=* | --libdi=* | --libd=*) - libdir=$ac_optarg ;; - - -libexecdir | --libexecdir | --libexecdi | --libexecd | --libexec \ - | --libexe | --libex | --libe) - ac_prev=libexecdir ;; - -libexecdir=* | --libexecdir=* | --libexecdi=* | --libexecd=* | --libexec=* \ - | --libexe=* | --libex=* | --libe=*) - libexecdir=$ac_optarg ;; - - -localedir | --localedir | --localedi | --localed | --locale) - ac_prev=localedir ;; - -localedir=* | --localedir=* | --localedi=* | --localed=* | --locale=*) - localedir=$ac_optarg ;; - - -localstatedir | --localstatedir | --localstatedi | --localstated \ - | --localstate | --localstat | --localsta | --localst | --locals) - ac_prev=localstatedir ;; - -localstatedir=* | --localstatedir=* | --localstatedi=* | --localstated=* \ - | --localstate=* | --localstat=* | --localsta=* | --localst=* | --locals=*) - localstatedir=$ac_optarg ;; - - -mandir | --mandir | --mandi | --mand | --man | --ma | --m) - ac_prev=mandir ;; - -mandir=* | --mandir=* | --mandi=* | --mand=* | --man=* | --ma=* | --m=*) - mandir=$ac_optarg ;; - - -nfp | --nfp | --nf) - # Obsolete; use --without-fp. - with_fp=no ;; - - -no-create | --no-create | --no-creat | --no-crea | --no-cre \ - | --no-cr | --no-c | -n) - no_create=yes ;; - - -no-recursion | --no-recursion | --no-recursio | --no-recursi \ - | --no-recurs | --no-recur | --no-recu | --no-rec | --no-re | --no-r) - no_recursion=yes ;; - - -oldincludedir | --oldincludedir | --oldincludedi | --oldincluded \ - | --oldinclude | --oldinclud | --oldinclu | --oldincl | --oldinc \ - | --oldin | --oldi | --old | --ol | --o) - ac_prev=oldincludedir ;; - -oldincludedir=* | --oldincludedir=* | --oldincludedi=* | --oldincluded=* \ - | --oldinclude=* | --oldinclud=* | --oldinclu=* | --oldincl=* | --oldinc=* \ - | --oldin=* | --oldi=* | --old=* | --ol=* | --o=*) - oldincludedir=$ac_optarg ;; - - -prefix | --prefix | --prefi | --pref | --pre | --pr | --p) - ac_prev=prefix ;; - -prefix=* | --prefix=* | --prefi=* | --pref=* | --pre=* | --pr=* | --p=*) - prefix=$ac_optarg ;; - - -program-prefix | --program-prefix | --program-prefi | --program-pref \ - | --program-pre | --program-pr | --program-p) - ac_prev=program_prefix ;; - -program-prefix=* | --program-prefix=* | --program-prefi=* \ - | --program-pref=* | --program-pre=* | --program-pr=* | --program-p=*) - program_prefix=$ac_optarg ;; - - -program-suffix | --program-suffix | --program-suffi | --program-suff \ - | --program-suf | --program-su | --program-s) - ac_prev=program_suffix ;; - -program-suffix=* | --program-suffix=* | --program-suffi=* \ - | --program-suff=* | --program-suf=* | --program-su=* | --program-s=*) - program_suffix=$ac_optarg ;; - - -program-transform-name | --program-transform-name \ - | --program-transform-nam | --program-transform-na \ - | --program-transform-n | --program-transform- \ - | --program-transform | --program-transfor \ - | --program-transfo | --program-transf \ - | --program-trans | --program-tran \ - | --progr-tra | --program-tr | --program-t) - ac_prev=program_transform_name ;; - -program-transform-name=* | --program-transform-name=* \ - | --program-transform-nam=* | --program-transform-na=* \ - | --program-transform-n=* | --program-transform-=* \ - | --program-transform=* | --program-transfor=* \ - | --program-transfo=* | --program-transf=* \ - | --program-trans=* | --program-tran=* \ - | --progr-tra=* | --program-tr=* | --program-t=*) - program_transform_name=$ac_optarg ;; - - -pdfdir | --pdfdir | --pdfdi | --pdfd | --pdf | --pd) - ac_prev=pdfdir ;; - -pdfdir=* | --pdfdir=* | --pdfdi=* | --pdfd=* | --pdf=* | --pd=*) - pdfdir=$ac_optarg ;; - - -psdir | --psdir | --psdi | --psd | --ps) - ac_prev=psdir ;; - -psdir=* | --psdir=* | --psdi=* | --psd=* | --ps=*) - psdir=$ac_optarg ;; - - -q | -quiet | --quiet | --quie | --qui | --qu | --q \ - | -silent | --silent | --silen | --sile | --sil) - silent=yes ;; - - -runstatedir | --runstatedir | --runstatedi | --runstated \ - | --runstate | --runstat | --runsta | --runst | --runs \ - | --run | --ru | --r) - ac_prev=runstatedir ;; - -runstatedir=* | --runstatedir=* | --runstatedi=* | --runstated=* \ - | --runstate=* | --runstat=* | --runsta=* | --runst=* | --runs=* \ - | --run=* | --ru=* | --r=*) - runstatedir=$ac_optarg ;; - - -sbindir | --sbindir | --sbindi | --sbind | --sbin | --sbi | --sb) - ac_prev=sbindir ;; - -sbindir=* | --sbindir=* | --sbindi=* | --sbind=* | --sbin=* \ - | --sbi=* | --sb=*) - sbindir=$ac_optarg ;; - - -sharedstatedir | --sharedstatedir | --sharedstatedi \ - | --sharedstated | --sharedstate | --sharedstat | --sharedsta \ - | --sharedst | --shareds | --shared | --share | --shar \ - | --sha | --sh) - ac_prev=sharedstatedir ;; - -sharedstatedir=* | --sharedstatedir=* | --sharedstatedi=* \ - | --sharedstated=* | --sharedstate=* | --sharedstat=* | --sharedsta=* \ - | --sharedst=* | --shareds=* | --shared=* | --share=* | --shar=* \ - | --sha=* | --sh=*) - sharedstatedir=$ac_optarg ;; - - -site | --site | --sit) - ac_prev=site ;; - -site=* | --site=* | --sit=*) - site=$ac_optarg ;; - - -srcdir | --srcdir | --srcdi | --srcd | --src | --sr) - ac_prev=srcdir ;; - -srcdir=* | --srcdir=* | --srcdi=* | --srcd=* | --src=* | --sr=*) - srcdir=$ac_optarg ;; - - -sysconfdir | --sysconfdir | --sysconfdi | --sysconfd | --sysconf \ - | --syscon | --sysco | --sysc | --sys | --sy) - ac_prev=sysconfdir ;; - -sysconfdir=* | --sysconfdir=* | --sysconfdi=* | --sysconfd=* | --sysconf=* \ - | --syscon=* | --sysco=* | --sysc=* | --sys=* | --sy=*) - sysconfdir=$ac_optarg ;; - - -target | --target | --targe | --targ | --tar | --ta | --t) - ac_prev=target_alias ;; - -target=* | --target=* | --targe=* | --targ=* | --tar=* | --ta=* | --t=*) - target_alias=$ac_optarg ;; - - -v | -verbose | --verbose | --verbos | --verbo | --verb) - verbose=yes ;; - - -version | --version | --versio | --versi | --vers | -V) - ac_init_version=: ;; - - -with-* | --with-*) - ac_useropt=`expr "x$ac_option" : 'x-*with-\([^=]*\)'` - # Reject names that are not valid shell variable names. - expr "x$ac_useropt" : ".*[^-+._$as_cr_alnum]" >/dev/null && - as_fn_error $? "invalid package name: $ac_useropt" - ac_useropt_orig=$ac_useropt - ac_useropt=`$as_echo "$ac_useropt" | sed 's/[-+.]/_/g'` - case $ac_user_opts in - *" -"with_$ac_useropt" -"*) ;; - *) ac_unrecognized_opts="$ac_unrecognized_opts$ac_unrecognized_sep--with-$ac_useropt_orig" - ac_unrecognized_sep=', ';; - esac - eval with_$ac_useropt=\$ac_optarg ;; - - -without-* | --without-*) - ac_useropt=`expr "x$ac_option" : 'x-*without-\(.*\)'` - # Reject names that are not valid shell variable names. - expr "x$ac_useropt" : ".*[^-+._$as_cr_alnum]" >/dev/null && - as_fn_error $? "invalid package name: $ac_useropt" - ac_useropt_orig=$ac_useropt - ac_useropt=`$as_echo "$ac_useropt" | sed 's/[-+.]/_/g'` - case $ac_user_opts in - *" -"with_$ac_useropt" -"*) ;; - *) ac_unrecognized_opts="$ac_unrecognized_opts$ac_unrecognized_sep--without-$ac_useropt_orig" - ac_unrecognized_sep=', ';; - esac - eval with_$ac_useropt=no ;; - - --x) - # Obsolete; use --with-x. - with_x=yes ;; - - -x-includes | --x-includes | --x-include | --x-includ | --x-inclu \ - | --x-incl | --x-inc | --x-in | --x-i) - ac_prev=x_includes ;; - -x-includes=* | --x-includes=* | --x-include=* | --x-includ=* | --x-inclu=* \ - | --x-incl=* | --x-inc=* | --x-in=* | --x-i=*) - x_includes=$ac_optarg ;; - - -x-libraries | --x-libraries | --x-librarie | --x-librari \ - | --x-librar | --x-libra | --x-libr | --x-lib | --x-li | --x-l) - ac_prev=x_libraries ;; - -x-libraries=* | --x-libraries=* | --x-librarie=* | --x-librari=* \ - | --x-librar=* | --x-libra=* | --x-libr=* | --x-lib=* | --x-li=* | --x-l=*) - x_libraries=$ac_optarg ;; - - -*) as_fn_error $? "unrecognized option: \`$ac_option' -Try \`$0 --help' for more information" - ;; - - *=*) - ac_envvar=`expr "x$ac_option" : 'x\([^=]*\)='` - # Reject names that are not valid shell variable names. - case $ac_envvar in #( - '' | [0-9]* | *[!_$as_cr_alnum]* ) - as_fn_error $? "invalid variable name: \`$ac_envvar'" ;; - esac - eval $ac_envvar=\$ac_optarg - export $ac_envvar ;; - - *) - # FIXME: should be removed in autoconf 3.0. - $as_echo "$as_me: WARNING: you should use --build, --host, --target" >&2 - expr "x$ac_option" : ".*[^-._$as_cr_alnum]" >/dev/null && - $as_echo "$as_me: WARNING: invalid host type: $ac_option" >&2 - : "${build_alias=$ac_option} ${host_alias=$ac_option} ${target_alias=$ac_option}" - ;; - - esac -done - -if test -n "$ac_prev"; then - ac_option=--`echo $ac_prev | sed 's/_/-/g'` - as_fn_error $? "missing argument to $ac_option" -fi - -if test -n "$ac_unrecognized_opts"; then - case $enable_option_checking in - no) ;; - fatal) as_fn_error $? "unrecognized options: $ac_unrecognized_opts" ;; - *) $as_echo "$as_me: WARNING: unrecognized options: $ac_unrecognized_opts" >&2 ;; - esac -fi - -# Check all directory arguments for consistency. -for ac_var in exec_prefix prefix bindir sbindir libexecdir datarootdir \ - datadir sysconfdir sharedstatedir localstatedir includedir \ - oldincludedir docdir infodir htmldir dvidir pdfdir psdir \ - libdir localedir mandir runstatedir -do - eval ac_val=\$$ac_var - # Remove trailing slashes. - case $ac_val in - */ ) - ac_val=`expr "X$ac_val" : 'X\(.*[^/]\)' \| "X$ac_val" : 'X\(.*\)'` - eval $ac_var=\$ac_val;; - esac - # Be sure to have absolute directory names. - case $ac_val in - [\\/$]* | ?:[\\/]* ) continue;; - NONE | '' ) case $ac_var in *prefix ) continue;; esac;; - esac - as_fn_error $? "expected an absolute directory name for --$ac_var: $ac_val" -done - -# There might be people who depend on the old broken behavior: `$host' -# used to hold the argument of --host etc. -# FIXME: To remove some day. -build=$build_alias -host=$host_alias -target=$target_alias - -# FIXME: To remove some day. -if test "x$host_alias" != x; then - if test "x$build_alias" = x; then - cross_compiling=maybe - elif test "x$build_alias" != "x$host_alias"; then - cross_compiling=yes - fi -fi - -ac_tool_prefix= -test -n "$host_alias" && ac_tool_prefix=$host_alias- - -test "$silent" = yes && exec 6>/dev/null - - -ac_pwd=`pwd` && test -n "$ac_pwd" && -ac_ls_di=`ls -di .` && -ac_pwd_ls_di=`cd "$ac_pwd" && ls -di .` || - as_fn_error $? "working directory cannot be determined" -test "X$ac_ls_di" = "X$ac_pwd_ls_di" || - as_fn_error $? "pwd does not report name of working directory" - - -# Find the source files, if location was not specified. -if test -z "$srcdir"; then - ac_srcdir_defaulted=yes - # Try the directory containing this script, then the parent directory. - ac_confdir=`$as_dirname -- "$as_myself" || -$as_expr X"$as_myself" : 'X\(.*[^/]\)//*[^/][^/]*/*$' \| \ - X"$as_myself" : 'X\(//\)[^/]' \| \ - X"$as_myself" : 'X\(//\)$' \| \ - X"$as_myself" : 'X\(/\)' \| . 2>/dev/null || -$as_echo X"$as_myself" | - sed '/^X\(.*[^/]\)\/\/*[^/][^/]*\/*$/{ - s//\1/ - q - } - /^X\(\/\/\)[^/].*/{ - s//\1/ - q - } - /^X\(\/\/\)$/{ - s//\1/ - q - } - /^X\(\/\).*/{ - s//\1/ - q - } - s/.*/./; q'` - srcdir=$ac_confdir - if test ! -r "$srcdir/$ac_unique_file"; then - srcdir=.. - fi -else - ac_srcdir_defaulted=no -fi -if test ! -r "$srcdir/$ac_unique_file"; then - test "$ac_srcdir_defaulted" = yes && srcdir="$ac_confdir or .." - as_fn_error $? "cannot find sources ($ac_unique_file) in $srcdir" -fi -ac_msg="sources are in $srcdir, but \`cd $srcdir' does not work" -ac_abs_confdir=`( - cd "$srcdir" && test -r "./$ac_unique_file" || as_fn_error $? "$ac_msg" - pwd)` -# When building in place, set srcdir=. -if test "$ac_abs_confdir" = "$ac_pwd"; then - srcdir=. -fi -# Remove unnecessary trailing slashes from srcdir. -# Double slashes in file names in object file debugging info -# mess up M-x gdb in Emacs. -case $srcdir in -*/) srcdir=`expr "X$srcdir" : 'X\(.*[^/]\)' \| "X$srcdir" : 'X\(.*\)'`;; -esac -for ac_var in $ac_precious_vars; do - eval ac_env_${ac_var}_set=\${${ac_var}+set} - eval ac_env_${ac_var}_value=\$${ac_var} - eval ac_cv_env_${ac_var}_set=\${${ac_var}+set} - eval ac_cv_env_${ac_var}_value=\$${ac_var} -done - -# -# Report the --help message. -# -if test "$ac_init_help" = "long"; then - # Omit some internal or obsolete options to make the list less imposing. - # This message is too long to be a string in the A/UX 3.1 sh. - cat <<_ACEOF -\`configure' configures Munipack 0.5.9 to adapt to many kinds of systems. - -Usage: $0 [OPTION]... [VAR=VALUE]... - -To assign environment variables (e.g., CC, CFLAGS...), specify them as -VAR=VALUE. See below for descriptions of some of the useful variables. - -Defaults for the options are specified in brackets. - -Configuration: - -h, --help display this help and exit - --help=short display options specific to this package - --help=recursive display the short help of all the included packages - -V, --version display version information and exit - -q, --quiet, --silent do not print \`checking ...' messages - --cache-file=FILE cache test results in FILE [disabled] - -C, --config-cache alias for \`--cache-file=config.cache' - -n, --no-create do not create output files - --srcdir=DIR find the sources in DIR [configure dir or \`..'] - -Installation directories: - --prefix=PREFIX install architecture-independent files in PREFIX - @<:@@S|@ac_default_prefix@:>@ - --exec-prefix=EPREFIX install architecture-dependent files in EPREFIX - @<:@PREFIX@:>@ - -By default, \`make install' will install all the files in -\`$ac_default_prefix/bin', \`$ac_default_prefix/lib' etc. You can specify -an installation prefix other than \`$ac_default_prefix' using \`--prefix', -for instance \`--prefix=\$HOME'. - -For better control, use the options below. - -Fine tuning of the installation directories: - --bindir=DIR user executables [EPREFIX/bin] - --sbindir=DIR system admin executables [EPREFIX/sbin] - --libexecdir=DIR program executables [EPREFIX/libexec] - --sysconfdir=DIR read-only single-machine data [PREFIX/etc] - --sharedstatedir=DIR modifiable architecture-independent data [PREFIX/com] - --localstatedir=DIR modifiable single-machine data [PREFIX/var] - --runstatedir=DIR modifiable per-process data [LOCALSTATEDIR/run] - --libdir=DIR object code libraries [EPREFIX/lib] - --includedir=DIR C header files [PREFIX/include] - --oldincludedir=DIR C header files for non-gcc [/usr/include] - --datarootdir=DIR read-only arch.-independent data root [PREFIX/share] - --datadir=DIR read-only architecture-independent data [DATAROOTDIR] - --infodir=DIR info documentation [DATAROOTDIR/info] - --localedir=DIR locale-dependent data [DATAROOTDIR/locale] - --mandir=DIR man documentation [DATAROOTDIR/man] - --docdir=DIR documentation root @<:@DATAROOTDIR/doc/munipack@:>@ - --htmldir=DIR html documentation [DOCDIR] - --dvidir=DIR dvi documentation [DOCDIR] - --pdfdir=DIR pdf documentation [DOCDIR] - --psdir=DIR ps documentation [DOCDIR] -_ACEOF - - cat <<\_ACEOF - -Program names: - --program-prefix=PREFIX prepend PREFIX to installed program names - --program-suffix=SUFFIX append SUFFIX to installed program names - --program-transform-name=PROGRAM run sed PROGRAM on installed program names - -System types: - --build=BUILD configure for building on BUILD [guessed] -_ACEOF -fi - -if test -n "$ac_init_help"; then - case $ac_init_help in - short | recursive ) echo "Configuration of Munipack 0.5.9:";; - esac - cat <<\_ACEOF - -Optional Features: - --disable-option-checking ignore unrecognized --enable/--with options - --disable-FEATURE do not include FEATURE (same as --enable-FEATURE=no) - --enable-FEATURE[=ARG] include FEATURE [ARG=yes] - --enable-silent-rules less verbose build output (undo: "make V=1") - --disable-silent-rules verbose build output (undo: "make V=0") - --enable-dependency-tracking - do not reject slow dependency extractors - --disable-dependency-tracking - speeds up one-time build - --disable-vo disable Virtual Observatory support - --disable-cli disable Command-line User Interface - --disable-gui disable Graphic User Interface - --enable-bundle install to self-contained directory (given - BUNDLEDIR) - -Optional Packages: - --with-PACKAGE[=ARG] use PACKAGE [ARG=yes] - --without-PACKAGE do not use PACKAGE (same as --with-PACKAGE=no) - --with-wxdir=PATH Use uninstalled version of wxWidgets in PATH - --with-wx-config=CONFIG wx-config script to use (optional) - --with-wx-prefix=PREFIX Prefix where wxWidgets is installed (optional) - --with-wx-exec-prefix=PREFIX - Exec prefix where wxWidgets is installed (optional) - -Some influential environment variables: - CC C compiler command - CFLAGS C compiler flags - LDFLAGS linker flags, e.g. -L if you have libraries in a - nonstandard directory - LIBS libraries to pass to the linker, e.g. -l - CPPFLAGS (Objective) C/C++ preprocessor flags, e.g. -I if - you have headers in a nonstandard directory - CXX C++ compiler command - CXXFLAGS C++ compiler flags - CPP C preprocessor - FC Fortran compiler command - FCFLAGS Fortran compiler flags - F77 Fortran 77 compiler command - FFLAGS Fortran 77 compiler flags - BUNDLEDIR prefix of self-contained directory @<:@/opt/munipack@:>@ - -Use these variables to override the choices made by `configure' or to help -it to find libraries and programs with nonstandard names/locations. - -Report bugs to >. -Munipack home page: . -_ACEOF -ac_status=$? -fi - -if test "$ac_init_help" = "recursive"; then - # If there are subdirs, report their specific --help. - for ac_dir in : $ac_subdirs_all; do test "x$ac_dir" = x: && continue - test -d "$ac_dir" || - { cd "$srcdir" && ac_pwd=`pwd` && srcdir=. && test -d "$ac_dir"; } || - continue - ac_builddir=. - -case "$ac_dir" in -.) ac_dir_suffix= ac_top_builddir_sub=. ac_top_build_prefix= ;; -*) - ac_dir_suffix=/`$as_echo "$ac_dir" | sed 's|^\.[\\/]||'` - # A ".." for each directory in $ac_dir_suffix. - ac_top_builddir_sub=`$as_echo "$ac_dir_suffix" | sed 's|/[^\\/]*|/..|g;s|/||'` - case $ac_top_builddir_sub in - "") ac_top_builddir_sub=. ac_top_build_prefix= ;; - *) ac_top_build_prefix=$ac_top_builddir_sub/ ;; - esac ;; -esac -ac_abs_top_builddir=$ac_pwd -ac_abs_builddir=$ac_pwd$ac_dir_suffix -# for backward compatibility: -ac_top_builddir=$ac_top_build_prefix - -case $srcdir in - .) # We are building in place. - ac_srcdir=. - ac_top_srcdir=$ac_top_builddir_sub - ac_abs_top_srcdir=$ac_pwd ;; - [\\/]* | ?:[\\/]* ) # Absolute name. - ac_srcdir=$srcdir$ac_dir_suffix; - ac_top_srcdir=$srcdir - ac_abs_top_srcdir=$srcdir ;; - *) # Relative name. - ac_srcdir=$ac_top_build_prefix$srcdir$ac_dir_suffix - ac_top_srcdir=$ac_top_build_prefix$srcdir - ac_abs_top_srcdir=$ac_pwd/$srcdir ;; -esac -ac_abs_srcdir=$ac_abs_top_srcdir$ac_dir_suffix - - cd "$ac_dir" || { ac_status=$?; continue; } - # Check for guested configure. - if test -f "$ac_srcdir/configure.gnu"; then - echo && - $SHELL "$ac_srcdir/configure.gnu" --help=recursive - elif test -f "$ac_srcdir/configure"; then - echo && - $SHELL "$ac_srcdir/configure" --help=recursive - else - $as_echo "$as_me: WARNING: no configuration information is in $ac_dir" >&2 - fi || ac_status=$? - cd "$ac_pwd" || { ac_status=$?; break; } - done -fi - -test -n "$ac_init_help" && exit $ac_status -if $ac_init_version; then - cat <<\_ACEOF -Munipack configure 0.5.9 -generated by GNU Autoconf 2.69 - -Copyright (C) 2012 Free Software Foundation, Inc. -This configure script is free software; the Free Software Foundation -gives unlimited permission to copy, distribute and modify it. -_ACEOF - exit -fi - -## ------------------------ ## -## Autoconf initialization. ## -## ------------------------ ## - -@%:@ ac_fn_c_try_compile LINENO -@%:@ -------------------------- -@%:@ Try to compile conftest.@S|@ac_ext, and return whether this succeeded. -ac_fn_c_try_compile () -{ - as_lineno=${as_lineno-"$1"} as_lineno_stack=as_lineno_stack=$as_lineno_stack - rm -f conftest.$ac_objext - if { { ac_try="$ac_compile" -case "(($ac_try" in - *\"* | *\`* | *\\*) ac_try_echo=\$ac_try;; - *) ac_try_echo=$ac_try;; -esac -eval ac_try_echo="\"\$as_me:${as_lineno-$LINENO}: $ac_try_echo\"" -$as_echo "$ac_try_echo"; } >&5 - (eval "$ac_compile") 2>conftest.err - ac_status=$? - if test -s conftest.err; then - grep -v '^ *+' conftest.err >conftest.er1 - cat conftest.er1 >&5 - mv -f conftest.er1 conftest.err - fi - $as_echo "$as_me:${as_lineno-$LINENO}: \$? = $ac_status" >&5 - test $ac_status = 0; } && { - test -z "$ac_c_werror_flag" || - test ! -s conftest.err - } && test -s conftest.$ac_objext; then : - ac_retval=0 -else - $as_echo "$as_me: failed program was:" >&5 -sed 's/^/| /' conftest.$ac_ext >&5 - - ac_retval=1 -fi - eval $as_lineno_stack; ${as_lineno_stack:+:} unset as_lineno - as_fn_set_status $ac_retval - -} @%:@ ac_fn_c_try_compile - -@%:@ ac_fn_cxx_try_compile LINENO -@%:@ ---------------------------- -@%:@ Try to compile conftest.@S|@ac_ext, and return whether this succeeded. -ac_fn_cxx_try_compile () -{ - as_lineno=${as_lineno-"$1"} as_lineno_stack=as_lineno_stack=$as_lineno_stack - rm -f conftest.$ac_objext - if { { ac_try="$ac_compile" -case "(($ac_try" in - *\"* | *\`* | *\\*) ac_try_echo=\$ac_try;; - *) ac_try_echo=$ac_try;; -esac -eval ac_try_echo="\"\$as_me:${as_lineno-$LINENO}: $ac_try_echo\"" -$as_echo "$ac_try_echo"; } >&5 - (eval "$ac_compile") 2>conftest.err - ac_status=$? - if test -s conftest.err; then - grep -v '^ *+' conftest.err >conftest.er1 - cat conftest.er1 >&5 - mv -f conftest.er1 conftest.err - fi - $as_echo "$as_me:${as_lineno-$LINENO}: \$? = $ac_status" >&5 - test $ac_status = 0; } && { - test -z "$ac_cxx_werror_flag" || - test ! -s conftest.err - } && test -s conftest.$ac_objext; then : - ac_retval=0 -else - $as_echo "$as_me: failed program was:" >&5 -sed 's/^/| /' conftest.$ac_ext >&5 - - ac_retval=1 -fi - eval $as_lineno_stack; ${as_lineno_stack:+:} unset as_lineno - as_fn_set_status $ac_retval - -} @%:@ ac_fn_cxx_try_compile - -@%:@ ac_fn_c_try_cpp LINENO -@%:@ ---------------------- -@%:@ Try to preprocess conftest.@S|@ac_ext, and return whether this succeeded. -ac_fn_c_try_cpp () -{ - as_lineno=${as_lineno-"$1"} as_lineno_stack=as_lineno_stack=$as_lineno_stack - if { { ac_try="$ac_cpp conftest.$ac_ext" -case "(($ac_try" in - *\"* | *\`* | *\\*) ac_try_echo=\$ac_try;; - *) ac_try_echo=$ac_try;; -esac -eval ac_try_echo="\"\$as_me:${as_lineno-$LINENO}: $ac_try_echo\"" -$as_echo "$ac_try_echo"; } >&5 - (eval "$ac_cpp conftest.$ac_ext") 2>conftest.err - ac_status=$? - if test -s conftest.err; then - grep -v '^ *+' conftest.err >conftest.er1 - cat conftest.er1 >&5 - mv -f conftest.er1 conftest.err - fi - $as_echo "$as_me:${as_lineno-$LINENO}: \$? = $ac_status" >&5 - test $ac_status = 0; } > conftest.i && { - test -z "$ac_c_preproc_warn_flag$ac_c_werror_flag" || - test ! -s conftest.err - }; then : - ac_retval=0 -else - $as_echo "$as_me: failed program was:" >&5 -sed 's/^/| /' conftest.$ac_ext >&5 - - ac_retval=1 -fi - eval $as_lineno_stack; ${as_lineno_stack:+:} unset as_lineno - as_fn_set_status $ac_retval - -} @%:@ ac_fn_c_try_cpp - -@%:@ ac_fn_fc_try_compile LINENO -@%:@ --------------------------- -@%:@ Try to compile conftest.@S|@ac_ext, and return whether this succeeded. -ac_fn_fc_try_compile () -{ - as_lineno=${as_lineno-"$1"} as_lineno_stack=as_lineno_stack=$as_lineno_stack - rm -f conftest.$ac_objext - if { { ac_try="$ac_compile" -case "(($ac_try" in - *\"* | *\`* | *\\*) ac_try_echo=\$ac_try;; - *) ac_try_echo=$ac_try;; -esac -eval ac_try_echo="\"\$as_me:${as_lineno-$LINENO}: $ac_try_echo\"" -$as_echo "$ac_try_echo"; } >&5 - (eval "$ac_compile") 2>conftest.err - ac_status=$? - if test -s conftest.err; then - grep -v '^ *+' conftest.err >conftest.er1 - cat conftest.er1 >&5 - mv -f conftest.er1 conftest.err - fi - $as_echo "$as_me:${as_lineno-$LINENO}: \$? = $ac_status" >&5 - test $ac_status = 0; } && { - test -z "$ac_fc_werror_flag" || - test ! -s conftest.err - } && test -s conftest.$ac_objext; then : - ac_retval=0 -else - $as_echo "$as_me: failed program was:" >&5 -sed 's/^/| /' conftest.$ac_ext >&5 - - ac_retval=1 -fi - eval $as_lineno_stack; ${as_lineno_stack:+:} unset as_lineno - as_fn_set_status $ac_retval - -} @%:@ ac_fn_fc_try_compile - -@%:@ ac_fn_c_try_run LINENO -@%:@ ---------------------- -@%:@ Try to link conftest.@S|@ac_ext, and return whether this succeeded. Assumes -@%:@ that executables *can* be run. -ac_fn_c_try_run () -{ - as_lineno=${as_lineno-"$1"} as_lineno_stack=as_lineno_stack=$as_lineno_stack - if { { ac_try="$ac_link" -case "(($ac_try" in - *\"* | *\`* | *\\*) ac_try_echo=\$ac_try;; - *) ac_try_echo=$ac_try;; -esac -eval ac_try_echo="\"\$as_me:${as_lineno-$LINENO}: $ac_try_echo\"" -$as_echo "$ac_try_echo"; } >&5 - (eval "$ac_link") 2>&5 - ac_status=$? - $as_echo "$as_me:${as_lineno-$LINENO}: \$? = $ac_status" >&5 - test $ac_status = 0; } && { ac_try='./conftest$ac_exeext' - { { case "(($ac_try" in - *\"* | *\`* | *\\*) ac_try_echo=\$ac_try;; - *) ac_try_echo=$ac_try;; -esac -eval ac_try_echo="\"\$as_me:${as_lineno-$LINENO}: $ac_try_echo\"" -$as_echo "$ac_try_echo"; } >&5 - (eval "$ac_try") 2>&5 - ac_status=$? - $as_echo "$as_me:${as_lineno-$LINENO}: \$? = $ac_status" >&5 - test $ac_status = 0; }; }; then : - ac_retval=0 -else - $as_echo "$as_me: program exited with status $ac_status" >&5 - $as_echo "$as_me: failed program was:" >&5 -sed 's/^/| /' conftest.$ac_ext >&5 - - ac_retval=$ac_status -fi - rm -rf conftest.dSYM conftest_ipa8_conftest.oo - eval $as_lineno_stack; ${as_lineno_stack:+:} unset as_lineno - as_fn_set_status $ac_retval - -} @%:@ ac_fn_c_try_run - -@%:@ ac_fn_c_check_type LINENO TYPE VAR INCLUDES -@%:@ ------------------------------------------- -@%:@ Tests whether TYPE exists after having included INCLUDES, setting cache -@%:@ variable VAR accordingly. -ac_fn_c_check_type () -{ - as_lineno=${as_lineno-"$1"} as_lineno_stack=as_lineno_stack=$as_lineno_stack - { $as_echo "$as_me:${as_lineno-$LINENO}: checking for $2" >&5 -$as_echo_n "checking for $2... " >&6; } -if eval \${$3+:} false; then : - $as_echo_n "(cached) " >&6 -else - eval "$3=no" - cat confdefs.h - <<_ACEOF >conftest.$ac_ext -/* end confdefs.h. */ -$4 -int -main () -{ -if (sizeof ($2)) - return 0; - ; - return 0; -} -_ACEOF -if ac_fn_c_try_compile "$LINENO"; then : - cat confdefs.h - <<_ACEOF >conftest.$ac_ext -/* end confdefs.h. */ -$4 -int -main () -{ -if (sizeof (($2))) - return 0; - ; - return 0; -} -_ACEOF -if ac_fn_c_try_compile "$LINENO"; then : - -else - eval "$3=yes" -fi -rm -f core conftest.err conftest.$ac_objext conftest.$ac_ext -fi -rm -f core conftest.err conftest.$ac_objext conftest.$ac_ext -fi -eval ac_res=\$$3 - { $as_echo "$as_me:${as_lineno-$LINENO}: result: $ac_res" >&5 -$as_echo "$ac_res" >&6; } - eval $as_lineno_stack; ${as_lineno_stack:+:} unset as_lineno - -} @%:@ ac_fn_c_check_type - -@%:@ ac_fn_c_check_header_compile LINENO HEADER VAR INCLUDES -@%:@ ------------------------------------------------------- -@%:@ Tests whether HEADER exists and can be compiled using the include files in -@%:@ INCLUDES, setting the cache variable VAR accordingly. -ac_fn_c_check_header_compile () -{ - as_lineno=${as_lineno-"$1"} as_lineno_stack=as_lineno_stack=$as_lineno_stack - { $as_echo "$as_me:${as_lineno-$LINENO}: checking for $2" >&5 -$as_echo_n "checking for $2... " >&6; } -if eval \${$3+:} false; then : - $as_echo_n "(cached) " >&6 -else - cat confdefs.h - <<_ACEOF >conftest.$ac_ext -/* end confdefs.h. */ -$4 -@%:@include <$2> -_ACEOF -if ac_fn_c_try_compile "$LINENO"; then : - eval "$3=yes" -else - eval "$3=no" -fi -rm -f core conftest.err conftest.$ac_objext conftest.$ac_ext -fi -eval ac_res=\$$3 - { $as_echo "$as_me:${as_lineno-$LINENO}: result: $ac_res" >&5 -$as_echo "$ac_res" >&6; } - eval $as_lineno_stack; ${as_lineno_stack:+:} unset as_lineno - -} @%:@ ac_fn_c_check_header_compile - -@%:@ ac_fn_c_check_header_mongrel LINENO HEADER VAR INCLUDES -@%:@ ------------------------------------------------------- -@%:@ Tests whether HEADER exists, giving a warning if it cannot be compiled using -@%:@ the include files in INCLUDES and setting the cache variable VAR -@%:@ accordingly. -ac_fn_c_check_header_mongrel () -{ - as_lineno=${as_lineno-"$1"} as_lineno_stack=as_lineno_stack=$as_lineno_stack - if eval \${$3+:} false; then : - { $as_echo "$as_me:${as_lineno-$LINENO}: checking for $2" >&5 -$as_echo_n "checking for $2... " >&6; } -if eval \${$3+:} false; then : - $as_echo_n "(cached) " >&6 -fi -eval ac_res=\$$3 - { $as_echo "$as_me:${as_lineno-$LINENO}: result: $ac_res" >&5 -$as_echo "$ac_res" >&6; } -else - # Is the header compilable? -{ $as_echo "$as_me:${as_lineno-$LINENO}: checking $2 usability" >&5 -$as_echo_n "checking $2 usability... " >&6; } -cat confdefs.h - <<_ACEOF >conftest.$ac_ext -/* end confdefs.h. */ -$4 -@%:@include <$2> -_ACEOF -if ac_fn_c_try_compile "$LINENO"; then : - ac_header_compiler=yes -else - ac_header_compiler=no -fi -rm -f core conftest.err conftest.$ac_objext conftest.$ac_ext -{ $as_echo "$as_me:${as_lineno-$LINENO}: result: $ac_header_compiler" >&5 -$as_echo "$ac_header_compiler" >&6; } - -# Is the header present? -{ $as_echo "$as_me:${as_lineno-$LINENO}: checking $2 presence" >&5 -$as_echo_n "checking $2 presence... " >&6; } -cat confdefs.h - <<_ACEOF >conftest.$ac_ext -/* end confdefs.h. */ -@%:@include <$2> -_ACEOF -if ac_fn_c_try_cpp "$LINENO"; then : - ac_header_preproc=yes -else - ac_header_preproc=no -fi -rm -f conftest.err conftest.i conftest.$ac_ext -{ $as_echo "$as_me:${as_lineno-$LINENO}: result: $ac_header_preproc" >&5 -$as_echo "$ac_header_preproc" >&6; } - -# So? What about this header? -case $ac_header_compiler:$ac_header_preproc:$ac_c_preproc_warn_flag in #(( - yes:no: ) - { $as_echo "$as_me:${as_lineno-$LINENO}: WARNING: $2: accepted by the compiler, rejected by the preprocessor!" >&5 -$as_echo "$as_me: WARNING: $2: accepted by the compiler, rejected by the preprocessor!" >&2;} - { $as_echo "$as_me:${as_lineno-$LINENO}: WARNING: $2: proceeding with the compiler's result" >&5 -$as_echo "$as_me: WARNING: $2: proceeding with the compiler's result" >&2;} - ;; - no:yes:* ) - { $as_echo "$as_me:${as_lineno-$LINENO}: WARNING: $2: present but cannot be compiled" >&5 -$as_echo "$as_me: WARNING: $2: present but cannot be compiled" >&2;} - { $as_echo "$as_me:${as_lineno-$LINENO}: WARNING: $2: check for missing prerequisite headers?" >&5 -$as_echo "$as_me: WARNING: $2: check for missing prerequisite headers?" >&2;} - { $as_echo "$as_me:${as_lineno-$LINENO}: WARNING: $2: see the Autoconf documentation" >&5 -$as_echo "$as_me: WARNING: $2: see the Autoconf documentation" >&2;} - { $as_echo "$as_me:${as_lineno-$LINENO}: WARNING: $2: section \"Present But Cannot Be Compiled\"" >&5 -$as_echo "$as_me: WARNING: $2: section \"Present But Cannot Be Compiled\"" >&2;} - { $as_echo "$as_me:${as_lineno-$LINENO}: WARNING: $2: proceeding with the compiler's result" >&5 -$as_echo "$as_me: WARNING: $2: proceeding with the compiler's result" >&2;} -( $as_echo "## -------------------------------------------------- ## -## Report this to Filip Hroch ## -## -------------------------------------------------- ##" - ) | sed "s/^/$as_me: WARNING: /" >&2 - ;; -esac - { $as_echo "$as_me:${as_lineno-$LINENO}: checking for $2" >&5 -$as_echo_n "checking for $2... " >&6; } -if eval \${$3+:} false; then : - $as_echo_n "(cached) " >&6 -else - eval "$3=\$ac_header_compiler" -fi -eval ac_res=\$$3 - { $as_echo "$as_me:${as_lineno-$LINENO}: result: $ac_res" >&5 -$as_echo "$ac_res" >&6; } -fi - eval $as_lineno_stack; ${as_lineno_stack:+:} unset as_lineno - -} @%:@ ac_fn_c_check_header_mongrel - -@%:@ ac_fn_c_try_link LINENO -@%:@ ----------------------- -@%:@ Try to link conftest.@S|@ac_ext, and return whether this succeeded. -ac_fn_c_try_link () -{ - as_lineno=${as_lineno-"$1"} as_lineno_stack=as_lineno_stack=$as_lineno_stack - rm -f conftest.$ac_objext conftest$ac_exeext - if { { ac_try="$ac_link" -case "(($ac_try" in - *\"* | *\`* | *\\*) ac_try_echo=\$ac_try;; - *) ac_try_echo=$ac_try;; -esac -eval ac_try_echo="\"\$as_me:${as_lineno-$LINENO}: $ac_try_echo\"" -$as_echo "$ac_try_echo"; } >&5 - (eval "$ac_link") 2>conftest.err - ac_status=$? - if test -s conftest.err; then - grep -v '^ *+' conftest.err >conftest.er1 - cat conftest.er1 >&5 - mv -f conftest.er1 conftest.err - fi - $as_echo "$as_me:${as_lineno-$LINENO}: \$? = $ac_status" >&5 - test $ac_status = 0; } && { - test -z "$ac_c_werror_flag" || - test ! -s conftest.err - } && test -s conftest$ac_exeext && { - test "$cross_compiling" = yes || - test -x conftest$ac_exeext - }; then : - ac_retval=0 -else - $as_echo "$as_me: failed program was:" >&5 -sed 's/^/| /' conftest.$ac_ext >&5 - - ac_retval=1 -fi - # Delete the IPA/IPO (Inter Procedural Analysis/Optimization) information - # created by the PGI compiler (conftest_ipa8_conftest.oo), as it would - # interfere with the next link command; also delete a directory that is - # left behind by Apple's compiler. We do this before executing the actions. - rm -rf conftest.dSYM conftest_ipa8_conftest.oo - eval $as_lineno_stack; ${as_lineno_stack:+:} unset as_lineno - as_fn_set_status $ac_retval - -} @%:@ ac_fn_c_try_link - -@%:@ ac_fn_f77_try_compile LINENO -@%:@ ---------------------------- -@%:@ Try to compile conftest.@S|@ac_ext, and return whether this succeeded. -ac_fn_f77_try_compile () -{ - as_lineno=${as_lineno-"$1"} as_lineno_stack=as_lineno_stack=$as_lineno_stack - rm -f conftest.$ac_objext - if { { ac_try="$ac_compile" -case "(($ac_try" in - *\"* | *\`* | *\\*) ac_try_echo=\$ac_try;; - *) ac_try_echo=$ac_try;; -esac -eval ac_try_echo="\"\$as_me:${as_lineno-$LINENO}: $ac_try_echo\"" -$as_echo "$ac_try_echo"; } >&5 - (eval "$ac_compile") 2>conftest.err - ac_status=$? - if test -s conftest.err; then - grep -v '^ *+' conftest.err >conftest.er1 - cat conftest.er1 >&5 - mv -f conftest.er1 conftest.err - fi - $as_echo "$as_me:${as_lineno-$LINENO}: \$? = $ac_status" >&5 - test $ac_status = 0; } && { - test -z "$ac_f77_werror_flag" || - test ! -s conftest.err - } && test -s conftest.$ac_objext; then : - ac_retval=0 -else - $as_echo "$as_me: failed program was:" >&5 -sed 's/^/| /' conftest.$ac_ext >&5 - - ac_retval=1 -fi - eval $as_lineno_stack; ${as_lineno_stack:+:} unset as_lineno - as_fn_set_status $ac_retval - -} @%:@ ac_fn_f77_try_compile -cat >config.log <<_ACEOF -This file contains any messages produced by compilers while -running configure, to aid debugging if configure makes a mistake. - -It was created by Munipack $as_me 0.5.9, which was -generated by GNU Autoconf 2.69. Invocation command line was - - $ $0 $@ - -_ACEOF -exec 5>>config.log -{ -cat <<_ASUNAME -## --------- ## -## Platform. ## -## --------- ## - -hostname = `(hostname || uname -n) 2>/dev/null | sed 1q` -uname -m = `(uname -m) 2>/dev/null || echo unknown` -uname -r = `(uname -r) 2>/dev/null || echo unknown` -uname -s = `(uname -s) 2>/dev/null || echo unknown` -uname -v = `(uname -v) 2>/dev/null || echo unknown` - -/usr/bin/uname -p = `(/usr/bin/uname -p) 2>/dev/null || echo unknown` -/bin/uname -X = `(/bin/uname -X) 2>/dev/null || echo unknown` - -/bin/arch = `(/bin/arch) 2>/dev/null || echo unknown` -/usr/bin/arch -k = `(/usr/bin/arch -k) 2>/dev/null || echo unknown` -/usr/convex/getsysinfo = `(/usr/convex/getsysinfo) 2>/dev/null || echo unknown` -/usr/bin/hostinfo = `(/usr/bin/hostinfo) 2>/dev/null || echo unknown` -/bin/machine = `(/bin/machine) 2>/dev/null || echo unknown` -/usr/bin/oslevel = `(/usr/bin/oslevel) 2>/dev/null || echo unknown` -/bin/universe = `(/bin/universe) 2>/dev/null || echo unknown` - -_ASUNAME - -as_save_IFS=$IFS; IFS=$PATH_SEPARATOR -for as_dir in $PATH -do - IFS=$as_save_IFS - test -z "$as_dir" && as_dir=. - $as_echo "PATH: $as_dir" - done -IFS=$as_save_IFS - -} >&5 - -cat >&5 <<_ACEOF - - -## ----------- ## -## Core tests. ## -## ----------- ## - -_ACEOF - - -# Keep a trace of the command line. -# Strip out --no-create and --no-recursion so they do not pile up. -# Strip out --silent because we don't want to record it for future runs. -# Also quote any args containing shell meta-characters. -# Make two passes to allow for proper duplicate-argument suppression. -ac_configure_args= -ac_configure_args0= -ac_configure_args1= -ac_must_keep_next=false -for ac_pass in 1 2 -do - for ac_arg - do - case $ac_arg in - -no-create | --no-c* | -n | -no-recursion | --no-r*) continue ;; - -q | -quiet | --quiet | --quie | --qui | --qu | --q \ - | -silent | --silent | --silen | --sile | --sil) - continue ;; - *\'*) - ac_arg=`$as_echo "$ac_arg" | sed "s/'/'\\\\\\\\''/g"` ;; - esac - case $ac_pass in - 1) as_fn_append ac_configure_args0 " '$ac_arg'" ;; - 2) - as_fn_append ac_configure_args1 " '$ac_arg'" - if test $ac_must_keep_next = true; then - ac_must_keep_next=false # Got value, back to normal. - else - case $ac_arg in - *=* | --config-cache | -C | -disable-* | --disable-* \ - | -enable-* | --enable-* | -gas | --g* | -nfp | --nf* \ - | -q | -quiet | --q* | -silent | --sil* | -v | -verb* \ - | -with-* | --with-* | -without-* | --without-* | --x) - case "$ac_configure_args0 " in - "$ac_configure_args1"*" '$ac_arg' "* ) continue ;; - esac - ;; - -* ) ac_must_keep_next=true ;; - esac - fi - as_fn_append ac_configure_args " '$ac_arg'" - ;; - esac - done -done -{ ac_configure_args0=; unset ac_configure_args0;} -{ ac_configure_args1=; unset ac_configure_args1;} - -# When interrupted or exit'd, cleanup temporary files, and complete -# config.log. We remove comments because anyway the quotes in there -# would cause problems or look ugly. -# WARNING: Use '\'' to represent an apostrophe within the trap. -# WARNING: Do not start the trap code with a newline, due to a FreeBSD 4.0 bug. -trap 'exit_status=$? - # Save into config.log some information that might help in debugging. - { - echo - - $as_echo "## ---------------- ## -## Cache variables. ## -## ---------------- ##" - echo - # The following way of writing the cache mishandles newlines in values, -( - for ac_var in `(set) 2>&1 | sed -n '\''s/^\([a-zA-Z_][a-zA-Z0-9_]*\)=.*/\1/p'\''`; do - eval ac_val=\$$ac_var - case $ac_val in #( - *${as_nl}*) - case $ac_var in #( - *_cv_*) { $as_echo "$as_me:${as_lineno-$LINENO}: WARNING: cache variable $ac_var contains a newline" >&5 -$as_echo "$as_me: WARNING: cache variable $ac_var contains a newline" >&2;} ;; - esac - case $ac_var in #( - _ | IFS | as_nl) ;; #( - BASH_ARGV | BASH_SOURCE) eval $ac_var= ;; #( - *) { eval $ac_var=; unset $ac_var;} ;; - esac ;; - esac - done - (set) 2>&1 | - case $as_nl`(ac_space='\'' '\''; set) 2>&1` in #( - *${as_nl}ac_space=\ *) - sed -n \ - "s/'\''/'\''\\\\'\'''\''/g; - s/^\\([_$as_cr_alnum]*_cv_[_$as_cr_alnum]*\\)=\\(.*\\)/\\1='\''\\2'\''/p" - ;; #( - *) - sed -n "/^[_$as_cr_alnum]*_cv_[_$as_cr_alnum]*=/p" - ;; - esac | - sort -) - echo - - $as_echo "## ----------------- ## -## Output variables. ## -## ----------------- ##" - echo - for ac_var in $ac_subst_vars - do - eval ac_val=\$$ac_var - case $ac_val in - *\'\''*) ac_val=`$as_echo "$ac_val" | sed "s/'\''/'\''\\\\\\\\'\'''\''/g"`;; - esac - $as_echo "$ac_var='\''$ac_val'\''" - done | sort - echo - - if test -n "$ac_subst_files"; then - $as_echo "## ------------------- ## -## File substitutions. ## -## ------------------- ##" - echo - for ac_var in $ac_subst_files - do - eval ac_val=\$$ac_var - case $ac_val in - *\'\''*) ac_val=`$as_echo "$ac_val" | sed "s/'\''/'\''\\\\\\\\'\'''\''/g"`;; - esac - $as_echo "$ac_var='\''$ac_val'\''" - done | sort - echo - fi - - if test -s confdefs.h; then - $as_echo "## ----------- ## -## confdefs.h. ## -## ----------- ##" - echo - cat confdefs.h - echo - fi - test "$ac_signal" != 0 && - $as_echo "$as_me: caught signal $ac_signal" - $as_echo "$as_me: exit $exit_status" - } >&5 - rm -f core *.core core.conftest.* && - rm -f -r conftest* confdefs* conf$$* $ac_clean_files && - exit $exit_status -' 0 -for ac_signal in 1 2 13 15; do - trap 'ac_signal='$ac_signal'; as_fn_exit 1' $ac_signal -done -ac_signal=0 - -# confdefs.h avoids OS command line length limits that DEFS can exceed. -rm -f -r conftest* confdefs.h - -$as_echo "/* confdefs.h */" > confdefs.h - -# Predefined preprocessor variables. - -cat >>confdefs.h <<_ACEOF -@%:@define PACKAGE_NAME "$PACKAGE_NAME" -_ACEOF - -cat >>confdefs.h <<_ACEOF -@%:@define PACKAGE_TARNAME "$PACKAGE_TARNAME" -_ACEOF - -cat >>confdefs.h <<_ACEOF -@%:@define PACKAGE_VERSION "$PACKAGE_VERSION" -_ACEOF - -cat >>confdefs.h <<_ACEOF -@%:@define PACKAGE_STRING "$PACKAGE_STRING" -_ACEOF - -cat >>confdefs.h <<_ACEOF -@%:@define PACKAGE_BUGREPORT "$PACKAGE_BUGREPORT" -_ACEOF - -cat >>confdefs.h <<_ACEOF -@%:@define PACKAGE_URL "$PACKAGE_URL" -_ACEOF - - -# Let the site file select an alternate cache file if it wants to. -# Prefer an explicitly selected file to automatically selected ones. -ac_site_file1=NONE -ac_site_file2=NONE -if test -n "$CONFIG_SITE"; then - # We do not want a PATH search for config.site. - case $CONFIG_SITE in @%:@(( - -*) ac_site_file1=./$CONFIG_SITE;; - */*) ac_site_file1=$CONFIG_SITE;; - *) ac_site_file1=./$CONFIG_SITE;; - esac -elif test "x$prefix" != xNONE; then - ac_site_file1=$prefix/share/config.site - ac_site_file2=$prefix/etc/config.site -else - ac_site_file1=$ac_default_prefix/share/config.site - ac_site_file2=$ac_default_prefix/etc/config.site -fi -for ac_site_file in "$ac_site_file1" "$ac_site_file2" -do - test "x$ac_site_file" = xNONE && continue - if test /dev/null != "$ac_site_file" && test -r "$ac_site_file"; then - { $as_echo "$as_me:${as_lineno-$LINENO}: loading site script $ac_site_file" >&5 -$as_echo "$as_me: loading site script $ac_site_file" >&6;} - sed 's/^/| /' "$ac_site_file" >&5 - . "$ac_site_file" \ - || { { $as_echo "$as_me:${as_lineno-$LINENO}: error: in \`$ac_pwd':" >&5 -$as_echo "$as_me: error: in \`$ac_pwd':" >&2;} -as_fn_error $? "failed to load site script $ac_site_file -See \`config.log' for more details" "$LINENO" 5; } - fi -done - -if test -r "$cache_file"; then - # Some versions of bash will fail to source /dev/null (special files - # actually), so we avoid doing that. DJGPP emulates it as a regular file. - if test /dev/null != "$cache_file" && test -f "$cache_file"; then - { $as_echo "$as_me:${as_lineno-$LINENO}: loading cache $cache_file" >&5 -$as_echo "$as_me: loading cache $cache_file" >&6;} - case $cache_file in - [\\/]* | ?:[\\/]* ) . "$cache_file";; - *) . "./$cache_file";; - esac - fi -else - { $as_echo "$as_me:${as_lineno-$LINENO}: creating cache $cache_file" >&5 -$as_echo "$as_me: creating cache $cache_file" >&6;} - >$cache_file -fi - -# Check that the precious variables saved in the cache have kept the same -# value. -ac_cache_corrupted=false -for ac_var in $ac_precious_vars; do - eval ac_old_set=\$ac_cv_env_${ac_var}_set - eval ac_new_set=\$ac_env_${ac_var}_set - eval ac_old_val=\$ac_cv_env_${ac_var}_value - eval ac_new_val=\$ac_env_${ac_var}_value - case $ac_old_set,$ac_new_set in - set,) - { $as_echo "$as_me:${as_lineno-$LINENO}: error: \`$ac_var' was set to \`$ac_old_val' in the previous run" >&5 -$as_echo "$as_me: error: \`$ac_var' was set to \`$ac_old_val' in the previous run" >&2;} - ac_cache_corrupted=: ;; - ,set) - { $as_echo "$as_me:${as_lineno-$LINENO}: error: \`$ac_var' was not set in the previous run" >&5 -$as_echo "$as_me: error: \`$ac_var' was not set in the previous run" >&2;} - ac_cache_corrupted=: ;; - ,);; - *) - if test "x$ac_old_val" != "x$ac_new_val"; then - # differences in whitespace do not lead to failure. - ac_old_val_w=`echo x $ac_old_val` - ac_new_val_w=`echo x $ac_new_val` - if test "$ac_old_val_w" != "$ac_new_val_w"; then - { $as_echo "$as_me:${as_lineno-$LINENO}: error: \`$ac_var' has changed since the previous run:" >&5 -$as_echo "$as_me: error: \`$ac_var' has changed since the previous run:" >&2;} - ac_cache_corrupted=: - else - { $as_echo "$as_me:${as_lineno-$LINENO}: warning: ignoring whitespace changes in \`$ac_var' since the previous run:" >&5 -$as_echo "$as_me: warning: ignoring whitespace changes in \`$ac_var' since the previous run:" >&2;} - eval $ac_var=\$ac_old_val - fi - { $as_echo "$as_me:${as_lineno-$LINENO}: former value: \`$ac_old_val'" >&5 -$as_echo "$as_me: former value: \`$ac_old_val'" >&2;} - { $as_echo "$as_me:${as_lineno-$LINENO}: current value: \`$ac_new_val'" >&5 -$as_echo "$as_me: current value: \`$ac_new_val'" >&2;} - fi;; - esac - # Pass precious variables to config.status. - if test "$ac_new_set" = set; then - case $ac_new_val in - *\'*) ac_arg=$ac_var=`$as_echo "$ac_new_val" | sed "s/'/'\\\\\\\\''/g"` ;; - *) ac_arg=$ac_var=$ac_new_val ;; - esac - case " $ac_configure_args " in - *" '$ac_arg' "*) ;; # Avoid dups. Use of quotes ensures accuracy. - *) as_fn_append ac_configure_args " '$ac_arg'" ;; - esac - fi -done -if $ac_cache_corrupted; then - { $as_echo "$as_me:${as_lineno-$LINENO}: error: in \`$ac_pwd':" >&5 -$as_echo "$as_me: error: in \`$ac_pwd':" >&2;} - { $as_echo "$as_me:${as_lineno-$LINENO}: error: changes in the environment can compromise the build" >&5 -$as_echo "$as_me: error: changes in the environment can compromise the build" >&2;} - as_fn_error $? "run \`make distclean' and/or \`rm $cache_file' and start over" "$LINENO" 5 -fi -## -------------------- ## -## Main body of script. ## -## -------------------- ## - -ac_ext=c -ac_cpp='$CPP $CPPFLAGS' -ac_compile='$CC -c $CFLAGS $CPPFLAGS conftest.$ac_ext >&5' -ac_link='$CC -o conftest$ac_exeext $CFLAGS $CPPFLAGS $LDFLAGS conftest.$ac_ext $LIBS >&5' -ac_compiler_gnu=$ac_cv_c_compiler_gnu - - - -develop=no - -if test "x$develop" = "xyes"; then - -$as_echo "@%:@define DEVELBUILD 1" >>confdefs.h - - -cat >>confdefs.h <<_ACEOF -@%:@define DATEBUILD `date +'"%F %T %Z"'` -_ACEOF - -fi - - -ac_aux_dir= -for ac_dir in "$srcdir" "$srcdir/.." "$srcdir/../.."; do - if test -f "$ac_dir/install-sh"; then - ac_aux_dir=$ac_dir - ac_install_sh="$ac_aux_dir/install-sh -c" - break - elif test -f "$ac_dir/install.sh"; then - ac_aux_dir=$ac_dir - ac_install_sh="$ac_aux_dir/install.sh -c" - break - elif test -f "$ac_dir/shtool"; then - ac_aux_dir=$ac_dir - ac_install_sh="$ac_aux_dir/shtool install -c" - break - fi -done -if test -z "$ac_aux_dir"; then - as_fn_error $? "cannot find install-sh, install.sh, or shtool in \"$srcdir\" \"$srcdir/..\" \"$srcdir/../..\"" "$LINENO" 5 -fi - -# These three variables are undocumented and unsupported, -# and are intended to be withdrawn in a future Autoconf release. -# They can cause serious problems if a builder's source tree is in a directory -# whose full name contains unusual characters. -ac_config_guess="$SHELL $ac_aux_dir/config.guess" # Please don't use this var. -ac_config_sub="$SHELL $ac_aux_dir/config.sub" # Please don't use this var. -ac_configure="$SHELL $ac_aux_dir/configure" # Please don't use this var. - - -# Make sure we can run config.sub. -$SHELL "$ac_aux_dir/config.sub" sun4 >/dev/null 2>&1 || - as_fn_error $? "cannot run $SHELL $ac_aux_dir/config.sub" "$LINENO" 5 - -{ $as_echo "$as_me:${as_lineno-$LINENO}: checking build system type" >&5 -$as_echo_n "checking build system type... " >&6; } -if ${ac_cv_build+:} false; then : - $as_echo_n "(cached) " >&6 -else - ac_build_alias=$build_alias -test "x$ac_build_alias" = x && - ac_build_alias=`$SHELL "$ac_aux_dir/config.guess"` -test "x$ac_build_alias" = x && - as_fn_error $? "cannot guess build type; you must specify one" "$LINENO" 5 -ac_cv_build=`$SHELL "$ac_aux_dir/config.sub" $ac_build_alias` || - as_fn_error $? "$SHELL $ac_aux_dir/config.sub $ac_build_alias failed" "$LINENO" 5 - -fi -{ $as_echo "$as_me:${as_lineno-$LINENO}: result: $ac_cv_build" >&5 -$as_echo "$ac_cv_build" >&6; } -case $ac_cv_build in -*-*-*) ;; -*) as_fn_error $? "invalid value of canonical build" "$LINENO" 5;; -esac -build=$ac_cv_build -ac_save_IFS=$IFS; IFS='-' -set x $ac_cv_build -shift -build_cpu=$1 -build_vendor=$2 -shift; shift -# Remember, the first character of IFS is used to create $*, -# except with old shells: -build_os=$* -IFS=$ac_save_IFS -case $build_os in *\ *) build_os=`echo "$build_os" | sed 's/ /-/g'`;; esac - - - -am__api_version='1.15' - -# Find a good install program. We prefer a C program (faster), -# so one script is as good as another. But avoid the broken or -# incompatible versions: -# SysV /etc/install, /usr/sbin/install -# SunOS /usr/etc/install -# IRIX /sbin/install -# AIX /bin/install -# AmigaOS /C/install, which installs bootblocks on floppy discs -# AIX 4 /usr/bin/installbsd, which doesn't work without a -g flag -# AFS /usr/afsws/bin/install, which mishandles nonexistent args -# SVR4 /usr/ucb/install, which tries to use the nonexistent group "staff" -# OS/2's system install, which has a completely different semantic -# ./install, which can be erroneously created by make from ./install.sh. -# Reject install programs that cannot install multiple files. -{ $as_echo "$as_me:${as_lineno-$LINENO}: checking for a BSD-compatible install" >&5 -$as_echo_n "checking for a BSD-compatible install... " >&6; } -if test -z "$INSTALL"; then -if ${ac_cv_path_install+:} false; then : - $as_echo_n "(cached) " >&6 -else - as_save_IFS=$IFS; IFS=$PATH_SEPARATOR -for as_dir in $PATH -do - IFS=$as_save_IFS - test -z "$as_dir" && as_dir=. - # Account for people who put trailing slashes in PATH elements. -case $as_dir/ in @%:@(( - ./ | .// | /[cC]/* | \ - /etc/* | /usr/sbin/* | /usr/etc/* | /sbin/* | /usr/afsws/bin/* | \ - ?:[\\/]os2[\\/]install[\\/]* | ?:[\\/]OS2[\\/]INSTALL[\\/]* | \ - /usr/ucb/* ) ;; - *) - # OSF1 and SCO ODT 3.0 have their own names for install. - # Don't use installbsd from OSF since it installs stuff as root - # by default. - for ac_prog in ginstall scoinst install; do - for ac_exec_ext in '' $ac_executable_extensions; do - if as_fn_executable_p "$as_dir/$ac_prog$ac_exec_ext"; then - if test $ac_prog = install && - grep dspmsg "$as_dir/$ac_prog$ac_exec_ext" >/dev/null 2>&1; then - # AIX install. It has an incompatible calling convention. - : - elif test $ac_prog = install && - grep pwplus "$as_dir/$ac_prog$ac_exec_ext" >/dev/null 2>&1; then - # program-specific install script used by HP pwplus--don't use. - : - else - rm -rf conftest.one conftest.two conftest.dir - echo one > conftest.one - echo two > conftest.two - mkdir conftest.dir - if "$as_dir/$ac_prog$ac_exec_ext" -c conftest.one conftest.two "`pwd`/conftest.dir" && - test -s conftest.one && test -s conftest.two && - test -s conftest.dir/conftest.one && - test -s conftest.dir/conftest.two - then - ac_cv_path_install="$as_dir/$ac_prog$ac_exec_ext -c" - break 3 - fi - fi - fi - done - done - ;; -esac - - done -IFS=$as_save_IFS - -rm -rf conftest.one conftest.two conftest.dir - -fi - if test "${ac_cv_path_install+set}" = set; then - INSTALL=$ac_cv_path_install - else - # As a last resort, use the slow shell script. Don't cache a - # value for INSTALL within a source directory, because that will - # break other packages using the cache if that directory is - # removed, or if the value is a relative name. - INSTALL=$ac_install_sh - fi -fi -{ $as_echo "$as_me:${as_lineno-$LINENO}: result: $INSTALL" >&5 -$as_echo "$INSTALL" >&6; } - -# Use test -z because SunOS4 sh mishandles braces in ${var-val}. -# It thinks the first close brace ends the variable substitution. -test -z "$INSTALL_PROGRAM" && INSTALL_PROGRAM='${INSTALL}' - -test -z "$INSTALL_SCRIPT" && INSTALL_SCRIPT='${INSTALL}' - -test -z "$INSTALL_DATA" && INSTALL_DATA='${INSTALL} -m 644' - -{ $as_echo "$as_me:${as_lineno-$LINENO}: checking whether build environment is sane" >&5 -$as_echo_n "checking whether build environment is sane... " >&6; } -# Reject unsafe characters in $srcdir or the absolute working directory -# name. Accept space and tab only in the latter. -am_lf=' -' -case `pwd` in - *[\\\"\#\$\&\'\`$am_lf]*) - as_fn_error $? "unsafe absolute working directory name" "$LINENO" 5;; -esac -case $srcdir in - *[\\\"\#\$\&\'\`$am_lf\ \ ]*) - as_fn_error $? "unsafe srcdir value: '$srcdir'" "$LINENO" 5;; -esac - -# Do 'set' in a subshell so we don't clobber the current shell's -# arguments. Must try -L first in case configure is actually a -# symlink; some systems play weird games with the mod time of symlinks -# (eg FreeBSD returns the mod time of the symlink's containing -# directory). -if ( - am_has_slept=no - for am_try in 1 2; do - echo "timestamp, slept: $am_has_slept" > conftest.file - set X `ls -Lt "$srcdir/configure" conftest.file 2> /dev/null` - if test "$*" = "X"; then - # -L didn't work. - set X `ls -t "$srcdir/configure" conftest.file` - fi - if test "$*" != "X $srcdir/configure conftest.file" \ - && test "$*" != "X conftest.file $srcdir/configure"; then - - # If neither matched, then we have a broken ls. This can happen - # if, for instance, CONFIG_SHELL is bash and it inherits a - # broken ls alias from the environment. This has actually - # happened. Such a system could not be considered "sane". - as_fn_error $? "ls -t appears to fail. Make sure there is not a broken - alias in your environment" "$LINENO" 5 - fi - if test "$2" = conftest.file || test $am_try -eq 2; then - break - fi - # Just in case. - sleep 1 - am_has_slept=yes - done - test "$2" = conftest.file - ) -then - # Ok. - : -else - as_fn_error $? "newly created file is older than distributed files! -Check your system clock" "$LINENO" 5 -fi -{ $as_echo "$as_me:${as_lineno-$LINENO}: result: yes" >&5 -$as_echo "yes" >&6; } -# If we didn't sleep, we still need to ensure time stamps of config.status and -# generated files are strictly newer. -am_sleep_pid= -if grep 'slept: no' conftest.file >/dev/null 2>&1; then - ( sleep 1 ) & - am_sleep_pid=$! -fi - -rm -f conftest.file - -test "$program_prefix" != NONE && - program_transform_name="s&^&$program_prefix&;$program_transform_name" -# Use a double $ so make ignores it. -test "$program_suffix" != NONE && - program_transform_name="s&\$&$program_suffix&;$program_transform_name" -# Double any \ or $. -# By default was `s,x,x', remove it if useless. -ac_script='s/[\\$]/&&/g;s/;s,x,x,$//' -program_transform_name=`$as_echo "$program_transform_name" | sed "$ac_script"` - -# Expand $ac_aux_dir to an absolute path. -am_aux_dir=`cd "$ac_aux_dir" && pwd` - -if test x"${MISSING+set}" != xset; then - case $am_aux_dir in - *\ * | *\ *) - MISSING="\${SHELL} \"$am_aux_dir/missing\"" ;; - *) - MISSING="\${SHELL} $am_aux_dir/missing" ;; - esac -fi -# Use eval to expand $SHELL -if eval "$MISSING --is-lightweight"; then - am_missing_run="$MISSING " -else - am_missing_run= - { $as_echo "$as_me:${as_lineno-$LINENO}: WARNING: 'missing' script is too old or missing" >&5 -$as_echo "$as_me: WARNING: 'missing' script is too old or missing" >&2;} -fi - -if test x"${install_sh+set}" != xset; then - case $am_aux_dir in - *\ * | *\ *) - install_sh="\${SHELL} '$am_aux_dir/install-sh'" ;; - *) - install_sh="\${SHELL} $am_aux_dir/install-sh" - esac -fi - -# Installed binaries are usually stripped using 'strip' when the user -# run "make install-strip". However 'strip' might not be the right -# tool to use in cross-compilation environments, therefore Automake -# will honor the 'STRIP' environment variable to overrule this program. -if test "$cross_compiling" != no; then - if test -n "$ac_tool_prefix"; then - # Extract the first word of "${ac_tool_prefix}strip", so it can be a program name with args. -set dummy ${ac_tool_prefix}strip; ac_word=$2 -{ $as_echo "$as_me:${as_lineno-$LINENO}: checking for $ac_word" >&5 -$as_echo_n "checking for $ac_word... " >&6; } -if ${ac_cv_prog_STRIP+:} false; then : - $as_echo_n "(cached) " >&6 -else - if test -n "$STRIP"; then - ac_cv_prog_STRIP="$STRIP" # Let the user override the test. -else -as_save_IFS=$IFS; IFS=$PATH_SEPARATOR -for as_dir in $PATH -do - IFS=$as_save_IFS - test -z "$as_dir" && as_dir=. - for ac_exec_ext in '' $ac_executable_extensions; do - if as_fn_executable_p "$as_dir/$ac_word$ac_exec_ext"; then - ac_cv_prog_STRIP="${ac_tool_prefix}strip" - $as_echo "$as_me:${as_lineno-$LINENO}: found $as_dir/$ac_word$ac_exec_ext" >&5 - break 2 - fi -done - done -IFS=$as_save_IFS - -fi -fi -STRIP=$ac_cv_prog_STRIP -if test -n "$STRIP"; then - { $as_echo "$as_me:${as_lineno-$LINENO}: result: $STRIP" >&5 -$as_echo "$STRIP" >&6; } -else - { $as_echo "$as_me:${as_lineno-$LINENO}: result: no" >&5 -$as_echo "no" >&6; } -fi - - -fi -if test -z "$ac_cv_prog_STRIP"; then - ac_ct_STRIP=$STRIP - # Extract the first word of "strip", so it can be a program name with args. -set dummy strip; ac_word=$2 -{ $as_echo "$as_me:${as_lineno-$LINENO}: checking for $ac_word" >&5 -$as_echo_n "checking for $ac_word... " >&6; } -if ${ac_cv_prog_ac_ct_STRIP+:} false; then : - $as_echo_n "(cached) " >&6 -else - if test -n "$ac_ct_STRIP"; then - ac_cv_prog_ac_ct_STRIP="$ac_ct_STRIP" # Let the user override the test. -else -as_save_IFS=$IFS; IFS=$PATH_SEPARATOR -for as_dir in $PATH -do - IFS=$as_save_IFS - test -z "$as_dir" && as_dir=. - for ac_exec_ext in '' $ac_executable_extensions; do - if as_fn_executable_p "$as_dir/$ac_word$ac_exec_ext"; then - ac_cv_prog_ac_ct_STRIP="strip" - $as_echo "$as_me:${as_lineno-$LINENO}: found $as_dir/$ac_word$ac_exec_ext" >&5 - break 2 - fi -done - done -IFS=$as_save_IFS - -fi -fi -ac_ct_STRIP=$ac_cv_prog_ac_ct_STRIP -if test -n "$ac_ct_STRIP"; then - { $as_echo "$as_me:${as_lineno-$LINENO}: result: $ac_ct_STRIP" >&5 -$as_echo "$ac_ct_STRIP" >&6; } -else - { $as_echo "$as_me:${as_lineno-$LINENO}: result: no" >&5 -$as_echo "no" >&6; } -fi - - if test "x$ac_ct_STRIP" = x; then - STRIP=":" - else - case $cross_compiling:$ac_tool_warned in -yes:) -{ $as_echo "$as_me:${as_lineno-$LINENO}: WARNING: using cross tools not prefixed with host triplet" >&5 -$as_echo "$as_me: WARNING: using cross tools not prefixed with host triplet" >&2;} -ac_tool_warned=yes ;; -esac - STRIP=$ac_ct_STRIP - fi -else - STRIP="$ac_cv_prog_STRIP" -fi - -fi -INSTALL_STRIP_PROGRAM="\$(install_sh) -c -s" - -{ $as_echo "$as_me:${as_lineno-$LINENO}: checking for a thread-safe mkdir -p" >&5 -$as_echo_n "checking for a thread-safe mkdir -p... " >&6; } -if test -z "$MKDIR_P"; then - if ${ac_cv_path_mkdir+:} false; then : - $as_echo_n "(cached) " >&6 -else - as_save_IFS=$IFS; IFS=$PATH_SEPARATOR -for as_dir in $PATH$PATH_SEPARATOR/opt/sfw/bin -do - IFS=$as_save_IFS - test -z "$as_dir" && as_dir=. - for ac_prog in mkdir gmkdir; do - for ac_exec_ext in '' $ac_executable_extensions; do - as_fn_executable_p "$as_dir/$ac_prog$ac_exec_ext" || continue - case `"$as_dir/$ac_prog$ac_exec_ext" --version 2>&1` in #( - 'mkdir (GNU coreutils) '* | \ - 'mkdir (coreutils) '* | \ - 'mkdir (fileutils) '4.1*) - ac_cv_path_mkdir=$as_dir/$ac_prog$ac_exec_ext - break 3;; - esac - done - done - done -IFS=$as_save_IFS - -fi - - test -d ./--version && rmdir ./--version - if test "${ac_cv_path_mkdir+set}" = set; then - MKDIR_P="$ac_cv_path_mkdir -p" - else - # As a last resort, use the slow shell script. Don't cache a - # value for MKDIR_P within a source directory, because that will - # break other packages using the cache if that directory is - # removed, or if the value is a relative name. - MKDIR_P="$ac_install_sh -d" - fi -fi -{ $as_echo "$as_me:${as_lineno-$LINENO}: result: $MKDIR_P" >&5 -$as_echo "$MKDIR_P" >&6; } - -for ac_prog in gawk mawk nawk awk -do - # Extract the first word of "$ac_prog", so it can be a program name with args. -set dummy $ac_prog; ac_word=$2 -{ $as_echo "$as_me:${as_lineno-$LINENO}: checking for $ac_word" >&5 -$as_echo_n "checking for $ac_word... " >&6; } -if ${ac_cv_prog_AWK+:} false; then : - $as_echo_n "(cached) " >&6 -else - if test -n "$AWK"; then - ac_cv_prog_AWK="$AWK" # Let the user override the test. -else -as_save_IFS=$IFS; IFS=$PATH_SEPARATOR -for as_dir in $PATH -do - IFS=$as_save_IFS - test -z "$as_dir" && as_dir=. - for ac_exec_ext in '' $ac_executable_extensions; do - if as_fn_executable_p "$as_dir/$ac_word$ac_exec_ext"; then - ac_cv_prog_AWK="$ac_prog" - $as_echo "$as_me:${as_lineno-$LINENO}: found $as_dir/$ac_word$ac_exec_ext" >&5 - break 2 - fi -done - done -IFS=$as_save_IFS - -fi -fi -AWK=$ac_cv_prog_AWK -if test -n "$AWK"; then - { $as_echo "$as_me:${as_lineno-$LINENO}: result: $AWK" >&5 -$as_echo "$AWK" >&6; } -else - { $as_echo "$as_me:${as_lineno-$LINENO}: result: no" >&5 -$as_echo "no" >&6; } -fi - - - test -n "$AWK" && break -done - -{ $as_echo "$as_me:${as_lineno-$LINENO}: checking whether ${MAKE-make} sets \$(MAKE)" >&5 -$as_echo_n "checking whether ${MAKE-make} sets \$(MAKE)... " >&6; } -set x ${MAKE-make} -ac_make=`$as_echo "$2" | sed 's/+/p/g; s/[^a-zA-Z0-9_]/_/g'` -if eval \${ac_cv_prog_make_${ac_make}_set+:} false; then : - $as_echo_n "(cached) " >&6 -else - cat >conftest.make <<\_ACEOF -SHELL = /bin/sh -all: - @echo '@@@%%%=$(MAKE)=@@@%%%' -_ACEOF -# GNU make sometimes prints "make[1]: Entering ...", which would confuse us. -case `${MAKE-make} -f conftest.make 2>/dev/null` in - *@@@%%%=?*=@@@%%%*) - eval ac_cv_prog_make_${ac_make}_set=yes;; - *) - eval ac_cv_prog_make_${ac_make}_set=no;; -esac -rm -f conftest.make -fi -if eval test \$ac_cv_prog_make_${ac_make}_set = yes; then - { $as_echo "$as_me:${as_lineno-$LINENO}: result: yes" >&5 -$as_echo "yes" >&6; } - SET_MAKE= -else - { $as_echo "$as_me:${as_lineno-$LINENO}: result: no" >&5 -$as_echo "no" >&6; } - SET_MAKE="MAKE=${MAKE-make}" -fi - -rm -rf .tst 2>/dev/null -mkdir .tst 2>/dev/null -if test -d .tst; then - am__leading_dot=. -else - am__leading_dot=_ -fi -rmdir .tst 2>/dev/null - -@%:@ Check whether --enable-silent-rules was given. -if test "${enable_silent_rules+set}" = set; then : - enableval=$enable_silent_rules; -fi - -case $enable_silent_rules in @%:@ ((( - yes) AM_DEFAULT_VERBOSITY=0;; - no) AM_DEFAULT_VERBOSITY=1;; - *) AM_DEFAULT_VERBOSITY=1;; -esac -am_make=${MAKE-make} -{ $as_echo "$as_me:${as_lineno-$LINENO}: checking whether $am_make supports nested variables" >&5 -$as_echo_n "checking whether $am_make supports nested variables... " >&6; } -if ${am_cv_make_support_nested_variables+:} false; then : - $as_echo_n "(cached) " >&6 -else - if $as_echo 'TRUE=$(BAR$(V)) -BAR0=false -BAR1=true -V=1 -am__doit: - @$(TRUE) -.PHONY: am__doit' | $am_make -f - >/dev/null 2>&1; then - am_cv_make_support_nested_variables=yes -else - am_cv_make_support_nested_variables=no -fi -fi -{ $as_echo "$as_me:${as_lineno-$LINENO}: result: $am_cv_make_support_nested_variables" >&5 -$as_echo "$am_cv_make_support_nested_variables" >&6; } -if test $am_cv_make_support_nested_variables = yes; then - AM_V='$(V)' - AM_DEFAULT_V='$(AM_DEFAULT_VERBOSITY)' -else - AM_V=$AM_DEFAULT_VERBOSITY - AM_DEFAULT_V=$AM_DEFAULT_VERBOSITY -fi -AM_BACKSLASH='\' - -if test "`cd $srcdir && pwd`" != "`pwd`"; then - # Use -I$(srcdir) only when $(srcdir) != ., so that make's output - # is not polluted with repeated "-I." - am__isrc=' -I$(srcdir)' - # test to see if srcdir already configured - if test -f $srcdir/config.status; then - as_fn_error $? "source directory already configured; run \"make distclean\" there first" "$LINENO" 5 - fi -fi - -# test whether we have cygpath -if test -z "$CYGPATH_W"; then - if (cygpath --version) >/dev/null 2>/dev/null; then - CYGPATH_W='cygpath -w' - else - CYGPATH_W=echo - fi -fi - - -# Define the identity of the package. - PACKAGE='munipack' - VERSION='0.5.9' - - -cat >>confdefs.h <<_ACEOF -@%:@define PACKAGE "$PACKAGE" -_ACEOF - - -cat >>confdefs.h <<_ACEOF -@%:@define VERSION "$VERSION" -_ACEOF - -# Some tools Automake needs. - -ACLOCAL=${ACLOCAL-"${am_missing_run}aclocal-${am__api_version}"} - - -AUTOCONF=${AUTOCONF-"${am_missing_run}autoconf"} - - -AUTOMAKE=${AUTOMAKE-"${am_missing_run}automake-${am__api_version}"} - - -AUTOHEADER=${AUTOHEADER-"${am_missing_run}autoheader"} - - -MAKEINFO=${MAKEINFO-"${am_missing_run}makeinfo"} - -# For better backward compatibility. To be removed once Automake 1.9.x -# dies out for good. For more background, see: -# -# -mkdir_p='$(MKDIR_P)' - -# We need awk for the "check" target (and possibly the TAP driver). The -# system "awk" is bad on some platforms. -# Always define AMTAR for backward compatibility. Yes, it's still used -# in the wild :-( We should find a proper way to deprecate it ... -AMTAR='$${TAR-tar}' - - -# We'll loop over all known methods to create a tar archive until one works. -_am_tools='gnutar pax cpio none' - -am__tar='$${TAR-tar} chof - "$$tardir"' am__untar='$${TAR-tar} xf -' - - - - - - -# POSIX will say in a future version that running "rm -f" with no argument -# is OK; and we want to be able to make that assumption in our Makefile -# recipes. So use an aggressive probe to check that the usage we want is -# actually supported "in the wild" to an acceptable degree. -# See automake bug#10828. -# To make any issue more visible, cause the running configure to be aborted -# by default if the 'rm' program in use doesn't match our expectations; the -# user can still override this though. -if rm -f && rm -fr && rm -rf; then : OK; else - cat >&2 <<'END' -Oops! - -Your 'rm' program seems unable to run without file operands specified -on the command line, even when the '-f' option is present. This is contrary -to the behaviour of most rm programs out there, and not conforming with -the upcoming POSIX standard: - -Please tell bug-automake@gnu.org about your system, including the value -of your $PATH and any error possibly output before this message. This -can help us improve future automake versions. - -END - if test x"$ACCEPT_INFERIOR_RM_PROGRAM" = x"yes"; then - echo 'Configuration will proceed anyway, since you have set the' >&2 - echo 'ACCEPT_INFERIOR_RM_PROGRAM variable to "yes"' >&2 - echo >&2 - else - cat >&2 <<'END' -Aborting the configuration process, to ensure you take notice of the issue. - -You can download and install GNU coreutils to get an 'rm' implementation -that behaves properly: . - -If you want to complete the configuration process using your problematic -'rm' anyway, export the environment variable ACCEPT_INFERIOR_RM_PROGRAM -to "yes", and re-run configure. - -END - as_fn_error $? "Your 'rm' program is bad, sorry." "$LINENO" 5 - fi -fi - - -ac_ext=c -ac_cpp='$CPP $CPPFLAGS' -ac_compile='$CC -c $CFLAGS $CPPFLAGS conftest.$ac_ext >&5' -ac_link='$CC -o conftest$ac_exeext $CFLAGS $CPPFLAGS $LDFLAGS conftest.$ac_ext $LIBS >&5' -ac_compiler_gnu=$ac_cv_c_compiler_gnu -if test -n "$ac_tool_prefix"; then - # Extract the first word of "${ac_tool_prefix}gcc", so it can be a program name with args. -set dummy ${ac_tool_prefix}gcc; ac_word=$2 -{ $as_echo "$as_me:${as_lineno-$LINENO}: checking for $ac_word" >&5 -$as_echo_n "checking for $ac_word... " >&6; } -if ${ac_cv_prog_CC+:} false; then : - $as_echo_n "(cached) " >&6 -else - if test -n "$CC"; then - ac_cv_prog_CC="$CC" # Let the user override the test. -else -as_save_IFS=$IFS; IFS=$PATH_SEPARATOR -for as_dir in $PATH -do - IFS=$as_save_IFS - test -z "$as_dir" && as_dir=. - for ac_exec_ext in '' $ac_executable_extensions; do - if as_fn_executable_p "$as_dir/$ac_word$ac_exec_ext"; then - ac_cv_prog_CC="${ac_tool_prefix}gcc" - $as_echo "$as_me:${as_lineno-$LINENO}: found $as_dir/$ac_word$ac_exec_ext" >&5 - break 2 - fi -done - done -IFS=$as_save_IFS - -fi -fi -CC=$ac_cv_prog_CC -if test -n "$CC"; then - { $as_echo "$as_me:${as_lineno-$LINENO}: result: $CC" >&5 -$as_echo "$CC" >&6; } -else - { $as_echo "$as_me:${as_lineno-$LINENO}: result: no" >&5 -$as_echo "no" >&6; } -fi - - -fi -if test -z "$ac_cv_prog_CC"; then - ac_ct_CC=$CC - # Extract the first word of "gcc", so it can be a program name with args. -set dummy gcc; ac_word=$2 -{ $as_echo "$as_me:${as_lineno-$LINENO}: checking for $ac_word" >&5 -$as_echo_n "checking for $ac_word... " >&6; } -if ${ac_cv_prog_ac_ct_CC+:} false; then : - $as_echo_n "(cached) " >&6 -else - if test -n "$ac_ct_CC"; then - ac_cv_prog_ac_ct_CC="$ac_ct_CC" # Let the user override the test. -else -as_save_IFS=$IFS; IFS=$PATH_SEPARATOR -for as_dir in $PATH -do - IFS=$as_save_IFS - test -z "$as_dir" && as_dir=. - for ac_exec_ext in '' $ac_executable_extensions; do - if as_fn_executable_p "$as_dir/$ac_word$ac_exec_ext"; then - ac_cv_prog_ac_ct_CC="gcc" - $as_echo "$as_me:${as_lineno-$LINENO}: found $as_dir/$ac_word$ac_exec_ext" >&5 - break 2 - fi -done - done -IFS=$as_save_IFS - -fi -fi -ac_ct_CC=$ac_cv_prog_ac_ct_CC -if test -n "$ac_ct_CC"; then - { $as_echo "$as_me:${as_lineno-$LINENO}: result: $ac_ct_CC" >&5 -$as_echo "$ac_ct_CC" >&6; } -else - { $as_echo "$as_me:${as_lineno-$LINENO}: result: no" >&5 -$as_echo "no" >&6; } -fi - - if test "x$ac_ct_CC" = x; then - CC="" - else - case $cross_compiling:$ac_tool_warned in -yes:) -{ $as_echo "$as_me:${as_lineno-$LINENO}: WARNING: using cross tools not prefixed with host triplet" >&5 -$as_echo "$as_me: WARNING: using cross tools not prefixed with host triplet" >&2;} -ac_tool_warned=yes ;; -esac - CC=$ac_ct_CC - fi -else - CC="$ac_cv_prog_CC" -fi - -if test -z "$CC"; then - if test -n "$ac_tool_prefix"; then - # Extract the first word of "${ac_tool_prefix}cc", so it can be a program name with args. -set dummy ${ac_tool_prefix}cc; ac_word=$2 -{ $as_echo "$as_me:${as_lineno-$LINENO}: checking for $ac_word" >&5 -$as_echo_n "checking for $ac_word... " >&6; } -if ${ac_cv_prog_CC+:} false; then : - $as_echo_n "(cached) " >&6 -else - if test -n "$CC"; then - ac_cv_prog_CC="$CC" # Let the user override the test. -else -as_save_IFS=$IFS; IFS=$PATH_SEPARATOR -for as_dir in $PATH -do - IFS=$as_save_IFS - test -z "$as_dir" && as_dir=. - for ac_exec_ext in '' $ac_executable_extensions; do - if as_fn_executable_p "$as_dir/$ac_word$ac_exec_ext"; then - ac_cv_prog_CC="${ac_tool_prefix}cc" - $as_echo "$as_me:${as_lineno-$LINENO}: found $as_dir/$ac_word$ac_exec_ext" >&5 - break 2 - fi -done - done -IFS=$as_save_IFS - -fi -fi -CC=$ac_cv_prog_CC -if test -n "$CC"; then - { $as_echo "$as_me:${as_lineno-$LINENO}: result: $CC" >&5 -$as_echo "$CC" >&6; } -else - { $as_echo "$as_me:${as_lineno-$LINENO}: result: no" >&5 -$as_echo "no" >&6; } -fi - - - fi -fi -if test -z "$CC"; then - # Extract the first word of "cc", so it can be a program name with args. -set dummy cc; ac_word=$2 -{ $as_echo "$as_me:${as_lineno-$LINENO}: checking for $ac_word" >&5 -$as_echo_n "checking for $ac_word... " >&6; } -if ${ac_cv_prog_CC+:} false; then : - $as_echo_n "(cached) " >&6 -else - if test -n "$CC"; then - ac_cv_prog_CC="$CC" # Let the user override the test. -else - ac_prog_rejected=no -as_save_IFS=$IFS; IFS=$PATH_SEPARATOR -for as_dir in $PATH -do - IFS=$as_save_IFS - test -z "$as_dir" && as_dir=. - for ac_exec_ext in '' $ac_executable_extensions; do - if as_fn_executable_p "$as_dir/$ac_word$ac_exec_ext"; then - if test "$as_dir/$ac_word$ac_exec_ext" = "/usr/ucb/cc"; then - ac_prog_rejected=yes - continue - fi - ac_cv_prog_CC="cc" - $as_echo "$as_me:${as_lineno-$LINENO}: found $as_dir/$ac_word$ac_exec_ext" >&5 - break 2 - fi -done - done -IFS=$as_save_IFS - -if test $ac_prog_rejected = yes; then - # We found a bogon in the path, so make sure we never use it. - set dummy $ac_cv_prog_CC - shift - if test $@%:@ != 0; then - # We chose a different compiler from the bogus one. - # However, it has the same basename, so the bogon will be chosen - # first if we set CC to just the basename; use the full file name. - shift - ac_cv_prog_CC="$as_dir/$ac_word${1+' '}$@" - fi -fi -fi -fi -CC=$ac_cv_prog_CC -if test -n "$CC"; then - { $as_echo "$as_me:${as_lineno-$LINENO}: result: $CC" >&5 -$as_echo "$CC" >&6; } -else - { $as_echo "$as_me:${as_lineno-$LINENO}: result: no" >&5 -$as_echo "no" >&6; } -fi - - -fi -if test -z "$CC"; then - if test -n "$ac_tool_prefix"; then - for ac_prog in cl.exe - do - # Extract the first word of "$ac_tool_prefix$ac_prog", so it can be a program name with args. -set dummy $ac_tool_prefix$ac_prog; ac_word=$2 -{ $as_echo "$as_me:${as_lineno-$LINENO}: checking for $ac_word" >&5 -$as_echo_n "checking for $ac_word... " >&6; } -if ${ac_cv_prog_CC+:} false; then : - $as_echo_n "(cached) " >&6 -else - if test -n "$CC"; then - ac_cv_prog_CC="$CC" # Let the user override the test. -else -as_save_IFS=$IFS; IFS=$PATH_SEPARATOR -for as_dir in $PATH -do - IFS=$as_save_IFS - test -z "$as_dir" && as_dir=. - for ac_exec_ext in '' $ac_executable_extensions; do - if as_fn_executable_p "$as_dir/$ac_word$ac_exec_ext"; then - ac_cv_prog_CC="$ac_tool_prefix$ac_prog" - $as_echo "$as_me:${as_lineno-$LINENO}: found $as_dir/$ac_word$ac_exec_ext" >&5 - break 2 - fi -done - done -IFS=$as_save_IFS - -fi -fi -CC=$ac_cv_prog_CC -if test -n "$CC"; then - { $as_echo "$as_me:${as_lineno-$LINENO}: result: $CC" >&5 -$as_echo "$CC" >&6; } -else - { $as_echo "$as_me:${as_lineno-$LINENO}: result: no" >&5 -$as_echo "no" >&6; } -fi - - - test -n "$CC" && break - done -fi -if test -z "$CC"; then - ac_ct_CC=$CC - for ac_prog in cl.exe -do - # Extract the first word of "$ac_prog", so it can be a program name with args. -set dummy $ac_prog; ac_word=$2 -{ $as_echo "$as_me:${as_lineno-$LINENO}: checking for $ac_word" >&5 -$as_echo_n "checking for $ac_word... " >&6; } -if ${ac_cv_prog_ac_ct_CC+:} false; then : - $as_echo_n "(cached) " >&6 -else - if test -n "$ac_ct_CC"; then - ac_cv_prog_ac_ct_CC="$ac_ct_CC" # Let the user override the test. -else -as_save_IFS=$IFS; IFS=$PATH_SEPARATOR -for as_dir in $PATH -do - IFS=$as_save_IFS - test -z "$as_dir" && as_dir=. - for ac_exec_ext in '' $ac_executable_extensions; do - if as_fn_executable_p "$as_dir/$ac_word$ac_exec_ext"; then - ac_cv_prog_ac_ct_CC="$ac_prog" - $as_echo "$as_me:${as_lineno-$LINENO}: found $as_dir/$ac_word$ac_exec_ext" >&5 - break 2 - fi -done - done -IFS=$as_save_IFS - -fi -fi -ac_ct_CC=$ac_cv_prog_ac_ct_CC -if test -n "$ac_ct_CC"; then - { $as_echo "$as_me:${as_lineno-$LINENO}: result: $ac_ct_CC" >&5 -$as_echo "$ac_ct_CC" >&6; } -else - { $as_echo "$as_me:${as_lineno-$LINENO}: result: no" >&5 -$as_echo "no" >&6; } -fi - - - test -n "$ac_ct_CC" && break -done - - if test "x$ac_ct_CC" = x; then - CC="" - else - case $cross_compiling:$ac_tool_warned in -yes:) -{ $as_echo "$as_me:${as_lineno-$LINENO}: WARNING: using cross tools not prefixed with host triplet" >&5 -$as_echo "$as_me: WARNING: using cross tools not prefixed with host triplet" >&2;} -ac_tool_warned=yes ;; -esac - CC=$ac_ct_CC - fi -fi - -fi - - -test -z "$CC" && { { $as_echo "$as_me:${as_lineno-$LINENO}: error: in \`$ac_pwd':" >&5 -$as_echo "$as_me: error: in \`$ac_pwd':" >&2;} -as_fn_error $? "no acceptable C compiler found in \$PATH -See \`config.log' for more details" "$LINENO" 5; } - -# Provide some information about the compiler. -$as_echo "$as_me:${as_lineno-$LINENO}: checking for C compiler version" >&5 -set X $ac_compile -ac_compiler=$2 -for ac_option in --version -v -V -qversion; do - { { ac_try="$ac_compiler $ac_option >&5" -case "(($ac_try" in - *\"* | *\`* | *\\*) ac_try_echo=\$ac_try;; - *) ac_try_echo=$ac_try;; -esac -eval ac_try_echo="\"\$as_me:${as_lineno-$LINENO}: $ac_try_echo\"" -$as_echo "$ac_try_echo"; } >&5 - (eval "$ac_compiler $ac_option >&5") 2>conftest.err - ac_status=$? - if test -s conftest.err; then - sed '10a\ -... rest of stderr output deleted ... - 10q' conftest.err >conftest.er1 - cat conftest.er1 >&5 - fi - rm -f conftest.er1 conftest.err - $as_echo "$as_me:${as_lineno-$LINENO}: \$? = $ac_status" >&5 - test $ac_status = 0; } -done - -cat confdefs.h - <<_ACEOF >conftest.$ac_ext -/* end confdefs.h. */ - -int -main () -{ - - ; - return 0; -} -_ACEOF -ac_clean_files_save=$ac_clean_files -ac_clean_files="$ac_clean_files a.out a.out.dSYM a.exe b.out" -# Try to create an executable without -o first, disregard a.out. -# It will help us diagnose broken compilers, and finding out an intuition -# of exeext. -{ $as_echo "$as_me:${as_lineno-$LINENO}: checking whether the C compiler works" >&5 -$as_echo_n "checking whether the C compiler works... " >&6; } -ac_link_default=`$as_echo "$ac_link" | sed 's/ -o *conftest[^ ]*//'` - -# The possible output files: -ac_files="a.out conftest.exe conftest a.exe a_out.exe b.out conftest.*" - -ac_rmfiles= -for ac_file in $ac_files -do - case $ac_file in - *.$ac_ext | *.xcoff | *.tds | *.d | *.pdb | *.xSYM | *.bb | *.bbg | *.map | *.inf | *.dSYM | *.o | *.obj ) ;; - * ) ac_rmfiles="$ac_rmfiles $ac_file";; - esac -done -rm -f $ac_rmfiles - -if { { ac_try="$ac_link_default" -case "(($ac_try" in - *\"* | *\`* | *\\*) ac_try_echo=\$ac_try;; - *) ac_try_echo=$ac_try;; -esac -eval ac_try_echo="\"\$as_me:${as_lineno-$LINENO}: $ac_try_echo\"" -$as_echo "$ac_try_echo"; } >&5 - (eval "$ac_link_default") 2>&5 - ac_status=$? - $as_echo "$as_me:${as_lineno-$LINENO}: \$? = $ac_status" >&5 - test $ac_status = 0; }; then : - # Autoconf-2.13 could set the ac_cv_exeext variable to `no'. -# So ignore a value of `no', otherwise this would lead to `EXEEXT = no' -# in a Makefile. We should not override ac_cv_exeext if it was cached, -# so that the user can short-circuit this test for compilers unknown to -# Autoconf. -for ac_file in $ac_files '' -do - test -f "$ac_file" || continue - case $ac_file in - *.$ac_ext | *.xcoff | *.tds | *.d | *.pdb | *.xSYM | *.bb | *.bbg | *.map | *.inf | *.dSYM | *.o | *.obj ) - ;; - [ab].out ) - # We found the default executable, but exeext='' is most - # certainly right. - break;; - *.* ) - if test "${ac_cv_exeext+set}" = set && test "$ac_cv_exeext" != no; - then :; else - ac_cv_exeext=`expr "$ac_file" : '[^.]*\(\..*\)'` - fi - # We set ac_cv_exeext here because the later test for it is not - # safe: cross compilers may not add the suffix if given an `-o' - # argument, so we may need to know it at that point already. - # Even if this section looks crufty: it has the advantage of - # actually working. - break;; - * ) - break;; - esac -done -test "$ac_cv_exeext" = no && ac_cv_exeext= - -else - ac_file='' -fi -if test -z "$ac_file"; then : - { $as_echo "$as_me:${as_lineno-$LINENO}: result: no" >&5 -$as_echo "no" >&6; } -$as_echo "$as_me: failed program was:" >&5 -sed 's/^/| /' conftest.$ac_ext >&5 - -{ { $as_echo "$as_me:${as_lineno-$LINENO}: error: in \`$ac_pwd':" >&5 -$as_echo "$as_me: error: in \`$ac_pwd':" >&2;} -as_fn_error 77 "C compiler cannot create executables -See \`config.log' for more details" "$LINENO" 5; } -else - { $as_echo "$as_me:${as_lineno-$LINENO}: result: yes" >&5 -$as_echo "yes" >&6; } -fi -{ $as_echo "$as_me:${as_lineno-$LINENO}: checking for C compiler default output file name" >&5 -$as_echo_n "checking for C compiler default output file name... " >&6; } -{ $as_echo "$as_me:${as_lineno-$LINENO}: result: $ac_file" >&5 -$as_echo "$ac_file" >&6; } -ac_exeext=$ac_cv_exeext - -rm -f -r a.out a.out.dSYM a.exe conftest$ac_cv_exeext b.out -ac_clean_files=$ac_clean_files_save -{ $as_echo "$as_me:${as_lineno-$LINENO}: checking for suffix of executables" >&5 -$as_echo_n "checking for suffix of executables... " >&6; } -if { { ac_try="$ac_link" -case "(($ac_try" in - *\"* | *\`* | *\\*) ac_try_echo=\$ac_try;; - *) ac_try_echo=$ac_try;; -esac -eval ac_try_echo="\"\$as_me:${as_lineno-$LINENO}: $ac_try_echo\"" -$as_echo "$ac_try_echo"; } >&5 - (eval "$ac_link") 2>&5 - ac_status=$? - $as_echo "$as_me:${as_lineno-$LINENO}: \$? = $ac_status" >&5 - test $ac_status = 0; }; then : - # If both `conftest.exe' and `conftest' are `present' (well, observable) -# catch `conftest.exe'. For instance with Cygwin, `ls conftest' will -# work properly (i.e., refer to `conftest.exe'), while it won't with -# `rm'. -for ac_file in conftest.exe conftest conftest.*; do - test -f "$ac_file" || continue - case $ac_file in - *.$ac_ext | *.xcoff | *.tds | *.d | *.pdb | *.xSYM | *.bb | *.bbg | *.map | *.inf | *.dSYM | *.o | *.obj ) ;; - *.* ) ac_cv_exeext=`expr "$ac_file" : '[^.]*\(\..*\)'` - break;; - * ) break;; - esac -done -else - { { $as_echo "$as_me:${as_lineno-$LINENO}: error: in \`$ac_pwd':" >&5 -$as_echo "$as_me: error: in \`$ac_pwd':" >&2;} -as_fn_error $? "cannot compute suffix of executables: cannot compile and link -See \`config.log' for more details" "$LINENO" 5; } -fi -rm -f conftest conftest$ac_cv_exeext -{ $as_echo "$as_me:${as_lineno-$LINENO}: result: $ac_cv_exeext" >&5 -$as_echo "$ac_cv_exeext" >&6; } - -rm -f conftest.$ac_ext -EXEEXT=$ac_cv_exeext -ac_exeext=$EXEEXT -cat confdefs.h - <<_ACEOF >conftest.$ac_ext -/* end confdefs.h. */ -@%:@include -int -main () -{ -FILE *f = fopen ("conftest.out", "w"); - return ferror (f) || fclose (f) != 0; - - ; - return 0; -} -_ACEOF -ac_clean_files="$ac_clean_files conftest.out" -# Check that the compiler produces executables we can run. If not, either -# the compiler is broken, or we cross compile. -{ $as_echo "$as_me:${as_lineno-$LINENO}: checking whether we are cross compiling" >&5 -$as_echo_n "checking whether we are cross compiling... " >&6; } -if test "$cross_compiling" != yes; then - { { ac_try="$ac_link" -case "(($ac_try" in - *\"* | *\`* | *\\*) ac_try_echo=\$ac_try;; - *) ac_try_echo=$ac_try;; -esac -eval ac_try_echo="\"\$as_me:${as_lineno-$LINENO}: $ac_try_echo\"" -$as_echo "$ac_try_echo"; } >&5 - (eval "$ac_link") 2>&5 - ac_status=$? - $as_echo "$as_me:${as_lineno-$LINENO}: \$? = $ac_status" >&5 - test $ac_status = 0; } - if { ac_try='./conftest$ac_cv_exeext' - { { case "(($ac_try" in - *\"* | *\`* | *\\*) ac_try_echo=\$ac_try;; - *) ac_try_echo=$ac_try;; -esac -eval ac_try_echo="\"\$as_me:${as_lineno-$LINENO}: $ac_try_echo\"" -$as_echo "$ac_try_echo"; } >&5 - (eval "$ac_try") 2>&5 - ac_status=$? - $as_echo "$as_me:${as_lineno-$LINENO}: \$? = $ac_status" >&5 - test $ac_status = 0; }; }; then - cross_compiling=no - else - if test "$cross_compiling" = maybe; then - cross_compiling=yes - else - { { $as_echo "$as_me:${as_lineno-$LINENO}: error: in \`$ac_pwd':" >&5 -$as_echo "$as_me: error: in \`$ac_pwd':" >&2;} -as_fn_error $? "cannot run C compiled programs. -If you meant to cross compile, use \`--host'. -See \`config.log' for more details" "$LINENO" 5; } - fi - fi -fi -{ $as_echo "$as_me:${as_lineno-$LINENO}: result: $cross_compiling" >&5 -$as_echo "$cross_compiling" >&6; } - -rm -f conftest.$ac_ext conftest$ac_cv_exeext conftest.out -ac_clean_files=$ac_clean_files_save -{ $as_echo "$as_me:${as_lineno-$LINENO}: checking for suffix of object files" >&5 -$as_echo_n "checking for suffix of object files... " >&6; } -if ${ac_cv_objext+:} false; then : - $as_echo_n "(cached) " >&6 -else - cat confdefs.h - <<_ACEOF >conftest.$ac_ext -/* end confdefs.h. */ - -int -main () -{ - - ; - return 0; -} -_ACEOF -rm -f conftest.o conftest.obj -if { { ac_try="$ac_compile" -case "(($ac_try" in - *\"* | *\`* | *\\*) ac_try_echo=\$ac_try;; - *) ac_try_echo=$ac_try;; -esac -eval ac_try_echo="\"\$as_me:${as_lineno-$LINENO}: $ac_try_echo\"" -$as_echo "$ac_try_echo"; } >&5 - (eval "$ac_compile") 2>&5 - ac_status=$? - $as_echo "$as_me:${as_lineno-$LINENO}: \$? = $ac_status" >&5 - test $ac_status = 0; }; then : - for ac_file in conftest.o conftest.obj conftest.*; do - test -f "$ac_file" || continue; - case $ac_file in - *.$ac_ext | *.xcoff | *.tds | *.d | *.pdb | *.xSYM | *.bb | *.bbg | *.map | *.inf | *.dSYM ) ;; - *) ac_cv_objext=`expr "$ac_file" : '.*\.\(.*\)'` - break;; - esac -done -else - $as_echo "$as_me: failed program was:" >&5 -sed 's/^/| /' conftest.$ac_ext >&5 - -{ { $as_echo "$as_me:${as_lineno-$LINENO}: error: in \`$ac_pwd':" >&5 -$as_echo "$as_me: error: in \`$ac_pwd':" >&2;} -as_fn_error $? "cannot compute suffix of object files: cannot compile -See \`config.log' for more details" "$LINENO" 5; } -fi -rm -f conftest.$ac_cv_objext conftest.$ac_ext -fi -{ $as_echo "$as_me:${as_lineno-$LINENO}: result: $ac_cv_objext" >&5 -$as_echo "$ac_cv_objext" >&6; } -OBJEXT=$ac_cv_objext -ac_objext=$OBJEXT -{ $as_echo "$as_me:${as_lineno-$LINENO}: checking whether we are using the GNU C compiler" >&5 -$as_echo_n "checking whether we are using the GNU C compiler... " >&6; } -if ${ac_cv_c_compiler_gnu+:} false; then : - $as_echo_n "(cached) " >&6 -else - cat confdefs.h - <<_ACEOF >conftest.$ac_ext -/* end confdefs.h. */ - -int -main () -{ -#ifndef __GNUC__ - choke me -#endif - - ; - return 0; -} -_ACEOF -if ac_fn_c_try_compile "$LINENO"; then : - ac_compiler_gnu=yes -else - ac_compiler_gnu=no -fi -rm -f core conftest.err conftest.$ac_objext conftest.$ac_ext -ac_cv_c_compiler_gnu=$ac_compiler_gnu - -fi -{ $as_echo "$as_me:${as_lineno-$LINENO}: result: $ac_cv_c_compiler_gnu" >&5 -$as_echo "$ac_cv_c_compiler_gnu" >&6; } -if test $ac_compiler_gnu = yes; then - GCC=yes -else - GCC= -fi -ac_test_CFLAGS=${CFLAGS+set} -ac_save_CFLAGS=$CFLAGS -{ $as_echo "$as_me:${as_lineno-$LINENO}: checking whether $CC accepts -g" >&5 -$as_echo_n "checking whether $CC accepts -g... " >&6; } -if ${ac_cv_prog_cc_g+:} false; then : - $as_echo_n "(cached) " >&6 -else - ac_save_c_werror_flag=$ac_c_werror_flag - ac_c_werror_flag=yes - ac_cv_prog_cc_g=no - CFLAGS="-g" - cat confdefs.h - <<_ACEOF >conftest.$ac_ext -/* end confdefs.h. */ - -int -main () -{ - - ; - return 0; -} -_ACEOF -if ac_fn_c_try_compile "$LINENO"; then : - ac_cv_prog_cc_g=yes -else - CFLAGS="" - cat confdefs.h - <<_ACEOF >conftest.$ac_ext -/* end confdefs.h. */ - -int -main () -{ - - ; - return 0; -} -_ACEOF -if ac_fn_c_try_compile "$LINENO"; then : - -else - ac_c_werror_flag=$ac_save_c_werror_flag - CFLAGS="-g" - cat confdefs.h - <<_ACEOF >conftest.$ac_ext -/* end confdefs.h. */ - -int -main () -{ - - ; - return 0; -} -_ACEOF -if ac_fn_c_try_compile "$LINENO"; then : - ac_cv_prog_cc_g=yes -fi -rm -f core conftest.err conftest.$ac_objext conftest.$ac_ext -fi -rm -f core conftest.err conftest.$ac_objext conftest.$ac_ext -fi -rm -f core conftest.err conftest.$ac_objext conftest.$ac_ext - ac_c_werror_flag=$ac_save_c_werror_flag -fi -{ $as_echo "$as_me:${as_lineno-$LINENO}: result: $ac_cv_prog_cc_g" >&5 -$as_echo "$ac_cv_prog_cc_g" >&6; } -if test "$ac_test_CFLAGS" = set; then - CFLAGS=$ac_save_CFLAGS -elif test $ac_cv_prog_cc_g = yes; then - if test "$GCC" = yes; then - CFLAGS="-g -O2" - else - CFLAGS="-g" - fi -else - if test "$GCC" = yes; then - CFLAGS="-O2" - else - CFLAGS= - fi -fi -{ $as_echo "$as_me:${as_lineno-$LINENO}: checking for $CC option to accept ISO C89" >&5 -$as_echo_n "checking for $CC option to accept ISO C89... " >&6; } -if ${ac_cv_prog_cc_c89+:} false; then : - $as_echo_n "(cached) " >&6 -else - ac_cv_prog_cc_c89=no -ac_save_CC=$CC -cat confdefs.h - <<_ACEOF >conftest.$ac_ext -/* end confdefs.h. */ -#include -#include -struct stat; -/* Most of the following tests are stolen from RCS 5.7's src/conf.sh. */ -struct buf { int x; }; -FILE * (*rcsopen) (struct buf *, struct stat *, int); -static char *e (p, i) - char **p; - int i; -{ - return p[i]; -} -static char *f (char * (*g) (char **, int), char **p, ...) -{ - char *s; - va_list v; - va_start (v,p); - s = g (p, va_arg (v,int)); - va_end (v); - return s; -} - -/* OSF 4.0 Compaq cc is some sort of almost-ANSI by default. It has - function prototypes and stuff, but not '\xHH' hex character constants. - These don't provoke an error unfortunately, instead are silently treated - as 'x'. The following induces an error, until -std is added to get - proper ANSI mode. Curiously '\x00'!='x' always comes out true, for an - array size at least. It's necessary to write '\x00'==0 to get something - that's true only with -std. */ -int osf4_cc_array ['\x00' == 0 ? 1 : -1]; - -/* IBM C 6 for AIX is almost-ANSI by default, but it replaces macro parameters - inside strings and character constants. */ -#define FOO(x) 'x' -int xlc6_cc_array[FOO(a) == 'x' ? 1 : -1]; - -int test (int i, double x); -struct s1 {int (*f) (int a);}; -struct s2 {int (*f) (double a);}; -int pairnames (int, char **, FILE *(*)(struct buf *, struct stat *, int), int, int); -int argc; -char **argv; -int -main () -{ -return f (e, argv, 0) != argv[0] || f (e, argv, 1) != argv[1]; - ; - return 0; -} -_ACEOF -for ac_arg in '' -qlanglvl=extc89 -qlanglvl=ansi -std \ - -Ae "-Aa -D_HPUX_SOURCE" "-Xc -D__EXTENSIONS__" -do - CC="$ac_save_CC $ac_arg" - if ac_fn_c_try_compile "$LINENO"; then : - ac_cv_prog_cc_c89=$ac_arg -fi -rm -f core conftest.err conftest.$ac_objext - test "x$ac_cv_prog_cc_c89" != "xno" && break -done -rm -f conftest.$ac_ext -CC=$ac_save_CC - -fi -# AC_CACHE_VAL -case "x$ac_cv_prog_cc_c89" in - x) - { $as_echo "$as_me:${as_lineno-$LINENO}: result: none needed" >&5 -$as_echo "none needed" >&6; } ;; - xno) - { $as_echo "$as_me:${as_lineno-$LINENO}: result: unsupported" >&5 -$as_echo "unsupported" >&6; } ;; - *) - CC="$CC $ac_cv_prog_cc_c89" - { $as_echo "$as_me:${as_lineno-$LINENO}: result: $ac_cv_prog_cc_c89" >&5 -$as_echo "$ac_cv_prog_cc_c89" >&6; } ;; -esac -if test "x$ac_cv_prog_cc_c89" != xno; then : - -fi - -ac_ext=c -ac_cpp='$CPP $CPPFLAGS' -ac_compile='$CC -c $CFLAGS $CPPFLAGS conftest.$ac_ext >&5' -ac_link='$CC -o conftest$ac_exeext $CFLAGS $CPPFLAGS $LDFLAGS conftest.$ac_ext $LIBS >&5' -ac_compiler_gnu=$ac_cv_c_compiler_gnu - -ac_ext=c -ac_cpp='$CPP $CPPFLAGS' -ac_compile='$CC -c $CFLAGS $CPPFLAGS conftest.$ac_ext >&5' -ac_link='$CC -o conftest$ac_exeext $CFLAGS $CPPFLAGS $LDFLAGS conftest.$ac_ext $LIBS >&5' -ac_compiler_gnu=$ac_cv_c_compiler_gnu -{ $as_echo "$as_me:${as_lineno-$LINENO}: checking whether $CC understands -c and -o together" >&5 -$as_echo_n "checking whether $CC understands -c and -o together... " >&6; } -if ${am_cv_prog_cc_c_o+:} false; then : - $as_echo_n "(cached) " >&6 -else - cat confdefs.h - <<_ACEOF >conftest.$ac_ext -/* end confdefs.h. */ - -int -main () -{ - - ; - return 0; -} -_ACEOF - # Make sure it works both with $CC and with simple cc. - # Following AC_PROG_CC_C_O, we do the test twice because some - # compilers refuse to overwrite an existing .o file with -o, - # though they will create one. - am_cv_prog_cc_c_o=yes - for am_i in 1 2; do - if { echo "$as_me:$LINENO: $CC -c conftest.$ac_ext -o conftest2.$ac_objext" >&5 - ($CC -c conftest.$ac_ext -o conftest2.$ac_objext) >&5 2>&5 - ac_status=$? - echo "$as_me:$LINENO: \$? = $ac_status" >&5 - (exit $ac_status); } \ - && test -f conftest2.$ac_objext; then - : OK - else - am_cv_prog_cc_c_o=no - break - fi - done - rm -f core conftest* - unset am_i -fi -{ $as_echo "$as_me:${as_lineno-$LINENO}: result: $am_cv_prog_cc_c_o" >&5 -$as_echo "$am_cv_prog_cc_c_o" >&6; } -if test "$am_cv_prog_cc_c_o" != yes; then - # Losing compiler, so override with the script. - # FIXME: It is wrong to rewrite CC. - # But if we don't then we get into trouble of one sort or another. - # A longer-term fix would be to have automake use am__CC in this case, - # and then we could set am__CC="\$(top_srcdir)/compile \$(CC)" - CC="$am_aux_dir/compile $CC" -fi -ac_ext=c -ac_cpp='$CPP $CPPFLAGS' -ac_compile='$CC -c $CFLAGS $CPPFLAGS conftest.$ac_ext >&5' -ac_link='$CC -o conftest$ac_exeext $CFLAGS $CPPFLAGS $LDFLAGS conftest.$ac_ext $LIBS >&5' -ac_compiler_gnu=$ac_cv_c_compiler_gnu - -DEPDIR="${am__leading_dot}deps" - -ac_config_commands="$ac_config_commands depfiles" - - -am_make=${MAKE-make} -cat > confinc << 'END' -am__doit: - @echo this is the am__doit target -.PHONY: am__doit -END -# If we don't find an include directive, just comment out the code. -{ $as_echo "$as_me:${as_lineno-$LINENO}: checking for style of include used by $am_make" >&5 -$as_echo_n "checking for style of include used by $am_make... " >&6; } -am__include="#" -am__quote= -_am_result=none -# First try GNU make style include. -echo "include confinc" > confmf -# Ignore all kinds of additional output from 'make'. -case `$am_make -s -f confmf 2> /dev/null` in #( -*the\ am__doit\ target*) - am__include=include - am__quote= - _am_result=GNU - ;; -esac -# Now try BSD make style include. -if test "$am__include" = "#"; then - echo '.include "confinc"' > confmf - case `$am_make -s -f confmf 2> /dev/null` in #( - *the\ am__doit\ target*) - am__include=.include - am__quote="\"" - _am_result=BSD - ;; - esac -fi - - -{ $as_echo "$as_me:${as_lineno-$LINENO}: result: $_am_result" >&5 -$as_echo "$_am_result" >&6; } -rm -f confinc confmf - -@%:@ Check whether --enable-dependency-tracking was given. -if test "${enable_dependency_tracking+set}" = set; then : - enableval=$enable_dependency_tracking; -fi - -if test "x$enable_dependency_tracking" != xno; then - am_depcomp="$ac_aux_dir/depcomp" - AMDEPBACKSLASH='\' - am__nodep='_no' -fi - if test "x$enable_dependency_tracking" != xno; then - AMDEP_TRUE= - AMDEP_FALSE='#' -else - AMDEP_TRUE='#' - AMDEP_FALSE= -fi - - - -depcc="$CC" am_compiler_list= - -{ $as_echo "$as_me:${as_lineno-$LINENO}: checking dependency style of $depcc" >&5 -$as_echo_n "checking dependency style of $depcc... " >&6; } -if ${am_cv_CC_dependencies_compiler_type+:} false; then : - $as_echo_n "(cached) " >&6 -else - if test -z "$AMDEP_TRUE" && test -f "$am_depcomp"; then - # We make a subdir and do the tests there. Otherwise we can end up - # making bogus files that we don't know about and never remove. For - # instance it was reported that on HP-UX the gcc test will end up - # making a dummy file named 'D' -- because '-MD' means "put the output - # in D". - rm -rf conftest.dir - mkdir conftest.dir - # Copy depcomp to subdir because otherwise we won't find it if we're - # using a relative directory. - cp "$am_depcomp" conftest.dir - cd conftest.dir - # We will build objects and dependencies in a subdirectory because - # it helps to detect inapplicable dependency modes. For instance - # both Tru64's cc and ICC support -MD to output dependencies as a - # side effect of compilation, but ICC will put the dependencies in - # the current directory while Tru64 will put them in the object - # directory. - mkdir sub - - am_cv_CC_dependencies_compiler_type=none - if test "$am_compiler_list" = ""; then - am_compiler_list=`sed -n 's/^#*\([a-zA-Z0-9]*\))$/\1/p' < ./depcomp` - fi - am__universal=false - case " $depcc " in #( - *\ -arch\ *\ -arch\ *) am__universal=true ;; - esac - - for depmode in $am_compiler_list; do - # Setup a source with many dependencies, because some compilers - # like to wrap large dependency lists on column 80 (with \), and - # we should not choose a depcomp mode which is confused by this. - # - # We need to recreate these files for each test, as the compiler may - # overwrite some of them when testing with obscure command lines. - # This happens at least with the AIX C compiler. - : > sub/conftest.c - for i in 1 2 3 4 5 6; do - echo '#include "conftst'$i'.h"' >> sub/conftest.c - # Using ": > sub/conftst$i.h" creates only sub/conftst1.h with - # Solaris 10 /bin/sh. - echo '/* dummy */' > sub/conftst$i.h - done - echo "${am__include} ${am__quote}sub/conftest.Po${am__quote}" > confmf - - # We check with '-c' and '-o' for the sake of the "dashmstdout" - # mode. It turns out that the SunPro C++ compiler does not properly - # handle '-M -o', and we need to detect this. Also, some Intel - # versions had trouble with output in subdirs. - am__obj=sub/conftest.${OBJEXT-o} - am__minus_obj="-o $am__obj" - case $depmode in - gcc) - # This depmode causes a compiler race in universal mode. - test "$am__universal" = false || continue - ;; - nosideeffect) - # After this tag, mechanisms are not by side-effect, so they'll - # only be used when explicitly requested. - if test "x$enable_dependency_tracking" = xyes; then - continue - else - break - fi - ;; - msvc7 | msvc7msys | msvisualcpp | msvcmsys) - # This compiler won't grok '-c -o', but also, the minuso test has - # not run yet. These depmodes are late enough in the game, and - # so weak that their functioning should not be impacted. - am__obj=conftest.${OBJEXT-o} - am__minus_obj= - ;; - none) break ;; - esac - if depmode=$depmode \ - source=sub/conftest.c object=$am__obj \ - depfile=sub/conftest.Po tmpdepfile=sub/conftest.TPo \ - $SHELL ./depcomp $depcc -c $am__minus_obj sub/conftest.c \ - >/dev/null 2>conftest.err && - grep sub/conftst1.h sub/conftest.Po > /dev/null 2>&1 && - grep sub/conftst6.h sub/conftest.Po > /dev/null 2>&1 && - grep $am__obj sub/conftest.Po > /dev/null 2>&1 && - ${MAKE-make} -s -f confmf > /dev/null 2>&1; then - # icc doesn't choke on unknown options, it will just issue warnings - # or remarks (even with -Werror). So we grep stderr for any message - # that says an option was ignored or not supported. - # When given -MP, icc 7.0 and 7.1 complain thusly: - # icc: Command line warning: ignoring option '-M'; no argument required - # The diagnosis changed in icc 8.0: - # icc: Command line remark: option '-MP' not supported - if (grep 'ignoring option' conftest.err || - grep 'not supported' conftest.err) >/dev/null 2>&1; then :; else - am_cv_CC_dependencies_compiler_type=$depmode - break - fi - fi - done - - cd .. - rm -rf conftest.dir -else - am_cv_CC_dependencies_compiler_type=none -fi - -fi -{ $as_echo "$as_me:${as_lineno-$LINENO}: result: $am_cv_CC_dependencies_compiler_type" >&5 -$as_echo "$am_cv_CC_dependencies_compiler_type" >&6; } -CCDEPMODE=depmode=$am_cv_CC_dependencies_compiler_type - - if - test "x$enable_dependency_tracking" != xno \ - && test "$am_cv_CC_dependencies_compiler_type" = gcc3; then - am__fastdepCC_TRUE= - am__fastdepCC_FALSE='#' -else - am__fastdepCC_TRUE='#' - am__fastdepCC_FALSE= -fi - - -ac_ext=cpp -ac_cpp='$CXXCPP $CPPFLAGS' -ac_compile='$CXX -c $CXXFLAGS $CPPFLAGS conftest.$ac_ext >&5' -ac_link='$CXX -o conftest$ac_exeext $CXXFLAGS $CPPFLAGS $LDFLAGS conftest.$ac_ext $LIBS >&5' -ac_compiler_gnu=$ac_cv_cxx_compiler_gnu -if test -z "$CXX"; then - if test -n "$CCC"; then - CXX=$CCC - else - if test -n "$ac_tool_prefix"; then - for ac_prog in g++ c++ gpp aCC CC cxx cc++ cl.exe FCC KCC RCC xlC_r xlC - do - # Extract the first word of "$ac_tool_prefix$ac_prog", so it can be a program name with args. -set dummy $ac_tool_prefix$ac_prog; ac_word=$2 -{ $as_echo "$as_me:${as_lineno-$LINENO}: checking for $ac_word" >&5 -$as_echo_n "checking for $ac_word... " >&6; } -if ${ac_cv_prog_CXX+:} false; then : - $as_echo_n "(cached) " >&6 -else - if test -n "$CXX"; then - ac_cv_prog_CXX="$CXX" # Let the user override the test. -else -as_save_IFS=$IFS; IFS=$PATH_SEPARATOR -for as_dir in $PATH -do - IFS=$as_save_IFS - test -z "$as_dir" && as_dir=. - for ac_exec_ext in '' $ac_executable_extensions; do - if as_fn_executable_p "$as_dir/$ac_word$ac_exec_ext"; then - ac_cv_prog_CXX="$ac_tool_prefix$ac_prog" - $as_echo "$as_me:${as_lineno-$LINENO}: found $as_dir/$ac_word$ac_exec_ext" >&5 - break 2 - fi -done - done -IFS=$as_save_IFS - -fi -fi -CXX=$ac_cv_prog_CXX -if test -n "$CXX"; then - { $as_echo "$as_me:${as_lineno-$LINENO}: result: $CXX" >&5 -$as_echo "$CXX" >&6; } -else - { $as_echo "$as_me:${as_lineno-$LINENO}: result: no" >&5 -$as_echo "no" >&6; } -fi - - - test -n "$CXX" && break - done -fi -if test -z "$CXX"; then - ac_ct_CXX=$CXX - for ac_prog in g++ c++ gpp aCC CC cxx cc++ cl.exe FCC KCC RCC xlC_r xlC -do - # Extract the first word of "$ac_prog", so it can be a program name with args. -set dummy $ac_prog; ac_word=$2 -{ $as_echo "$as_me:${as_lineno-$LINENO}: checking for $ac_word" >&5 -$as_echo_n "checking for $ac_word... " >&6; } -if ${ac_cv_prog_ac_ct_CXX+:} false; then : - $as_echo_n "(cached) " >&6 -else - if test -n "$ac_ct_CXX"; then - ac_cv_prog_ac_ct_CXX="$ac_ct_CXX" # Let the user override the test. -else -as_save_IFS=$IFS; IFS=$PATH_SEPARATOR -for as_dir in $PATH -do - IFS=$as_save_IFS - test -z "$as_dir" && as_dir=. - for ac_exec_ext in '' $ac_executable_extensions; do - if as_fn_executable_p "$as_dir/$ac_word$ac_exec_ext"; then - ac_cv_prog_ac_ct_CXX="$ac_prog" - $as_echo "$as_me:${as_lineno-$LINENO}: found $as_dir/$ac_word$ac_exec_ext" >&5 - break 2 - fi -done - done -IFS=$as_save_IFS - -fi -fi -ac_ct_CXX=$ac_cv_prog_ac_ct_CXX -if test -n "$ac_ct_CXX"; then - { $as_echo "$as_me:${as_lineno-$LINENO}: result: $ac_ct_CXX" >&5 -$as_echo "$ac_ct_CXX" >&6; } -else - { $as_echo "$as_me:${as_lineno-$LINENO}: result: no" >&5 -$as_echo "no" >&6; } -fi - - - test -n "$ac_ct_CXX" && break -done - - if test "x$ac_ct_CXX" = x; then - CXX="g++" - else - case $cross_compiling:$ac_tool_warned in -yes:) -{ $as_echo "$as_me:${as_lineno-$LINENO}: WARNING: using cross tools not prefixed with host triplet" >&5 -$as_echo "$as_me: WARNING: using cross tools not prefixed with host triplet" >&2;} -ac_tool_warned=yes ;; -esac - CXX=$ac_ct_CXX - fi -fi - - fi -fi -# Provide some information about the compiler. -$as_echo "$as_me:${as_lineno-$LINENO}: checking for C++ compiler version" >&5 -set X $ac_compile -ac_compiler=$2 -for ac_option in --version -v -V -qversion; do - { { ac_try="$ac_compiler $ac_option >&5" -case "(($ac_try" in - *\"* | *\`* | *\\*) ac_try_echo=\$ac_try;; - *) ac_try_echo=$ac_try;; -esac -eval ac_try_echo="\"\$as_me:${as_lineno-$LINENO}: $ac_try_echo\"" -$as_echo "$ac_try_echo"; } >&5 - (eval "$ac_compiler $ac_option >&5") 2>conftest.err - ac_status=$? - if test -s conftest.err; then - sed '10a\ -... rest of stderr output deleted ... - 10q' conftest.err >conftest.er1 - cat conftest.er1 >&5 - fi - rm -f conftest.er1 conftest.err - $as_echo "$as_me:${as_lineno-$LINENO}: \$? = $ac_status" >&5 - test $ac_status = 0; } -done - -{ $as_echo "$as_me:${as_lineno-$LINENO}: checking whether we are using the GNU C++ compiler" >&5 -$as_echo_n "checking whether we are using the GNU C++ compiler... " >&6; } -if ${ac_cv_cxx_compiler_gnu+:} false; then : - $as_echo_n "(cached) " >&6 -else - cat confdefs.h - <<_ACEOF >conftest.$ac_ext -/* end confdefs.h. */ - -int -main () -{ -#ifndef __GNUC__ - choke me -#endif - - ; - return 0; -} -_ACEOF -if ac_fn_cxx_try_compile "$LINENO"; then : - ac_compiler_gnu=yes -else - ac_compiler_gnu=no -fi -rm -f core conftest.err conftest.$ac_objext conftest.$ac_ext -ac_cv_cxx_compiler_gnu=$ac_compiler_gnu - -fi -{ $as_echo "$as_me:${as_lineno-$LINENO}: result: $ac_cv_cxx_compiler_gnu" >&5 -$as_echo "$ac_cv_cxx_compiler_gnu" >&6; } -if test $ac_compiler_gnu = yes; then - GXX=yes -else - GXX= -fi -ac_test_CXXFLAGS=${CXXFLAGS+set} -ac_save_CXXFLAGS=$CXXFLAGS -{ $as_echo "$as_me:${as_lineno-$LINENO}: checking whether $CXX accepts -g" >&5 -$as_echo_n "checking whether $CXX accepts -g... " >&6; } -if ${ac_cv_prog_cxx_g+:} false; then : - $as_echo_n "(cached) " >&6 -else - ac_save_cxx_werror_flag=$ac_cxx_werror_flag - ac_cxx_werror_flag=yes - ac_cv_prog_cxx_g=no - CXXFLAGS="-g" - cat confdefs.h - <<_ACEOF >conftest.$ac_ext -/* end confdefs.h. */ - -int -main () -{ - - ; - return 0; -} -_ACEOF -if ac_fn_cxx_try_compile "$LINENO"; then : - ac_cv_prog_cxx_g=yes -else - CXXFLAGS="" - cat confdefs.h - <<_ACEOF >conftest.$ac_ext -/* end confdefs.h. */ - -int -main () -{ - - ; - return 0; -} -_ACEOF -if ac_fn_cxx_try_compile "$LINENO"; then : - -else - ac_cxx_werror_flag=$ac_save_cxx_werror_flag - CXXFLAGS="-g" - cat confdefs.h - <<_ACEOF >conftest.$ac_ext -/* end confdefs.h. */ - -int -main () -{ - - ; - return 0; -} -_ACEOF -if ac_fn_cxx_try_compile "$LINENO"; then : - ac_cv_prog_cxx_g=yes -fi -rm -f core conftest.err conftest.$ac_objext conftest.$ac_ext -fi -rm -f core conftest.err conftest.$ac_objext conftest.$ac_ext -fi -rm -f core conftest.err conftest.$ac_objext conftest.$ac_ext - ac_cxx_werror_flag=$ac_save_cxx_werror_flag -fi -{ $as_echo "$as_me:${as_lineno-$LINENO}: result: $ac_cv_prog_cxx_g" >&5 -$as_echo "$ac_cv_prog_cxx_g" >&6; } -if test "$ac_test_CXXFLAGS" = set; then - CXXFLAGS=$ac_save_CXXFLAGS -elif test $ac_cv_prog_cxx_g = yes; then - if test "$GXX" = yes; then - CXXFLAGS="-g -O2" - else - CXXFLAGS="-g" - fi -else - if test "$GXX" = yes; then - CXXFLAGS="-O2" - else - CXXFLAGS= - fi -fi -ac_ext=c -ac_cpp='$CPP $CPPFLAGS' -ac_compile='$CC -c $CFLAGS $CPPFLAGS conftest.$ac_ext >&5' -ac_link='$CC -o conftest$ac_exeext $CFLAGS $CPPFLAGS $LDFLAGS conftest.$ac_ext $LIBS >&5' -ac_compiler_gnu=$ac_cv_c_compiler_gnu - -depcc="$CXX" am_compiler_list= - -{ $as_echo "$as_me:${as_lineno-$LINENO}: checking dependency style of $depcc" >&5 -$as_echo_n "checking dependency style of $depcc... " >&6; } -if ${am_cv_CXX_dependencies_compiler_type+:} false; then : - $as_echo_n "(cached) " >&6 -else - if test -z "$AMDEP_TRUE" && test -f "$am_depcomp"; then - # We make a subdir and do the tests there. Otherwise we can end up - # making bogus files that we don't know about and never remove. For - # instance it was reported that on HP-UX the gcc test will end up - # making a dummy file named 'D' -- because '-MD' means "put the output - # in D". - rm -rf conftest.dir - mkdir conftest.dir - # Copy depcomp to subdir because otherwise we won't find it if we're - # using a relative directory. - cp "$am_depcomp" conftest.dir - cd conftest.dir - # We will build objects and dependencies in a subdirectory because - # it helps to detect inapplicable dependency modes. For instance - # both Tru64's cc and ICC support -MD to output dependencies as a - # side effect of compilation, but ICC will put the dependencies in - # the current directory while Tru64 will put them in the object - # directory. - mkdir sub - - am_cv_CXX_dependencies_compiler_type=none - if test "$am_compiler_list" = ""; then - am_compiler_list=`sed -n 's/^#*\([a-zA-Z0-9]*\))$/\1/p' < ./depcomp` - fi - am__universal=false - case " $depcc " in #( - *\ -arch\ *\ -arch\ *) am__universal=true ;; - esac - - for depmode in $am_compiler_list; do - # Setup a source with many dependencies, because some compilers - # like to wrap large dependency lists on column 80 (with \), and - # we should not choose a depcomp mode which is confused by this. - # - # We need to recreate these files for each test, as the compiler may - # overwrite some of them when testing with obscure command lines. - # This happens at least with the AIX C compiler. - : > sub/conftest.c - for i in 1 2 3 4 5 6; do - echo '#include "conftst'$i'.h"' >> sub/conftest.c - # Using ": > sub/conftst$i.h" creates only sub/conftst1.h with - # Solaris 10 /bin/sh. - echo '/* dummy */' > sub/conftst$i.h - done - echo "${am__include} ${am__quote}sub/conftest.Po${am__quote}" > confmf - - # We check with '-c' and '-o' for the sake of the "dashmstdout" - # mode. It turns out that the SunPro C++ compiler does not properly - # handle '-M -o', and we need to detect this. Also, some Intel - # versions had trouble with output in subdirs. - am__obj=sub/conftest.${OBJEXT-o} - am__minus_obj="-o $am__obj" - case $depmode in - gcc) - # This depmode causes a compiler race in universal mode. - test "$am__universal" = false || continue - ;; - nosideeffect) - # After this tag, mechanisms are not by side-effect, so they'll - # only be used when explicitly requested. - if test "x$enable_dependency_tracking" = xyes; then - continue - else - break - fi - ;; - msvc7 | msvc7msys | msvisualcpp | msvcmsys) - # This compiler won't grok '-c -o', but also, the minuso test has - # not run yet. These depmodes are late enough in the game, and - # so weak that their functioning should not be impacted. - am__obj=conftest.${OBJEXT-o} - am__minus_obj= - ;; - none) break ;; - esac - if depmode=$depmode \ - source=sub/conftest.c object=$am__obj \ - depfile=sub/conftest.Po tmpdepfile=sub/conftest.TPo \ - $SHELL ./depcomp $depcc -c $am__minus_obj sub/conftest.c \ - >/dev/null 2>conftest.err && - grep sub/conftst1.h sub/conftest.Po > /dev/null 2>&1 && - grep sub/conftst6.h sub/conftest.Po > /dev/null 2>&1 && - grep $am__obj sub/conftest.Po > /dev/null 2>&1 && - ${MAKE-make} -s -f confmf > /dev/null 2>&1; then - # icc doesn't choke on unknown options, it will just issue warnings - # or remarks (even with -Werror). So we grep stderr for any message - # that says an option was ignored or not supported. - # When given -MP, icc 7.0 and 7.1 complain thusly: - # icc: Command line warning: ignoring option '-M'; no argument required - # The diagnosis changed in icc 8.0: - # icc: Command line remark: option '-MP' not supported - if (grep 'ignoring option' conftest.err || - grep 'not supported' conftest.err) >/dev/null 2>&1; then :; else - am_cv_CXX_dependencies_compiler_type=$depmode - break - fi - fi - done - - cd .. - rm -rf conftest.dir -else - am_cv_CXX_dependencies_compiler_type=none -fi - -fi -{ $as_echo "$as_me:${as_lineno-$LINENO}: result: $am_cv_CXX_dependencies_compiler_type" >&5 -$as_echo "$am_cv_CXX_dependencies_compiler_type" >&6; } -CXXDEPMODE=depmode=$am_cv_CXX_dependencies_compiler_type - - if - test "x$enable_dependency_tracking" != xno \ - && test "$am_cv_CXX_dependencies_compiler_type" = gcc3; then - am__fastdepCXX_TRUE= - am__fastdepCXX_FALSE='#' -else - am__fastdepCXX_TRUE='#' - am__fastdepCXX_FALSE= -fi - - -ac_ext=c -ac_cpp='$CPP $CPPFLAGS' -ac_compile='$CC -c $CFLAGS $CPPFLAGS conftest.$ac_ext >&5' -ac_link='$CC -o conftest$ac_exeext $CFLAGS $CPPFLAGS $LDFLAGS conftest.$ac_ext $LIBS >&5' -ac_compiler_gnu=$ac_cv_c_compiler_gnu -{ $as_echo "$as_me:${as_lineno-$LINENO}: checking how to run the C preprocessor" >&5 -$as_echo_n "checking how to run the C preprocessor... " >&6; } -# On Suns, sometimes $CPP names a directory. -if test -n "$CPP" && test -d "$CPP"; then - CPP= -fi -if test -z "$CPP"; then - if ${ac_cv_prog_CPP+:} false; then : - $as_echo_n "(cached) " >&6 -else - # Double quotes because CPP needs to be expanded - for CPP in "$CC -E" "$CC -E -traditional-cpp" "/lib/cpp" - do - ac_preproc_ok=false -for ac_c_preproc_warn_flag in '' yes -do - # Use a header file that comes with gcc, so configuring glibc - # with a fresh cross-compiler works. - # Prefer to if __STDC__ is defined, since - # exists even on freestanding compilers. - # On the NeXT, cc -E runs the code through the compiler's parser, - # not just through cpp. "Syntax error" is here to catch this case. - cat confdefs.h - <<_ACEOF >conftest.$ac_ext -/* end confdefs.h. */ -@%:@ifdef __STDC__ -@%:@ include -@%:@else -@%:@ include -@%:@endif - Syntax error -_ACEOF -if ac_fn_c_try_cpp "$LINENO"; then : - -else - # Broken: fails on valid input. -continue -fi -rm -f conftest.err conftest.i conftest.$ac_ext - - # OK, works on sane cases. Now check whether nonexistent headers - # can be detected and how. - cat confdefs.h - <<_ACEOF >conftest.$ac_ext -/* end confdefs.h. */ -@%:@include -_ACEOF -if ac_fn_c_try_cpp "$LINENO"; then : - # Broken: success on invalid input. -continue -else - # Passes both tests. -ac_preproc_ok=: -break -fi -rm -f conftest.err conftest.i conftest.$ac_ext - -done -# Because of `break', _AC_PREPROC_IFELSE's cleaning code was skipped. -rm -f conftest.i conftest.err conftest.$ac_ext -if $ac_preproc_ok; then : - break -fi - - done - ac_cv_prog_CPP=$CPP - -fi - CPP=$ac_cv_prog_CPP -else - ac_cv_prog_CPP=$CPP -fi -{ $as_echo "$as_me:${as_lineno-$LINENO}: result: $CPP" >&5 -$as_echo "$CPP" >&6; } -ac_preproc_ok=false -for ac_c_preproc_warn_flag in '' yes -do - # Use a header file that comes with gcc, so configuring glibc - # with a fresh cross-compiler works. - # Prefer to if __STDC__ is defined, since - # exists even on freestanding compilers. - # On the NeXT, cc -E runs the code through the compiler's parser, - # not just through cpp. "Syntax error" is here to catch this case. - cat confdefs.h - <<_ACEOF >conftest.$ac_ext -/* end confdefs.h. */ -@%:@ifdef __STDC__ -@%:@ include -@%:@else -@%:@ include -@%:@endif - Syntax error -_ACEOF -if ac_fn_c_try_cpp "$LINENO"; then : - -else - # Broken: fails on valid input. -continue -fi -rm -f conftest.err conftest.i conftest.$ac_ext - - # OK, works on sane cases. Now check whether nonexistent headers - # can be detected and how. - cat confdefs.h - <<_ACEOF >conftest.$ac_ext -/* end confdefs.h. */ -@%:@include -_ACEOF -if ac_fn_c_try_cpp "$LINENO"; then : - # Broken: success on invalid input. -continue -else - # Passes both tests. -ac_preproc_ok=: -break -fi -rm -f conftest.err conftest.i conftest.$ac_ext - -done -# Because of `break', _AC_PREPROC_IFELSE's cleaning code was skipped. -rm -f conftest.i conftest.err conftest.$ac_ext -if $ac_preproc_ok; then : - -else - { { $as_echo "$as_me:${as_lineno-$LINENO}: error: in \`$ac_pwd':" >&5 -$as_echo "$as_me: error: in \`$ac_pwd':" >&2;} -as_fn_error $? "C preprocessor \"$CPP\" fails sanity check -See \`config.log' for more details" "$LINENO" 5; } -fi - -ac_ext=c -ac_cpp='$CPP $CPPFLAGS' -ac_compile='$CC -c $CFLAGS $CPPFLAGS conftest.$ac_ext >&5' -ac_link='$CC -o conftest$ac_exeext $CFLAGS $CPPFLAGS $LDFLAGS conftest.$ac_ext $LIBS >&5' -ac_compiler_gnu=$ac_cv_c_compiler_gnu - -ac_ext=${ac_fc_srcext-f} -ac_compile='$FC -c $FCFLAGS $ac_fcflags_srcext conftest.$ac_ext >&5' -ac_link='$FC -o conftest$ac_exeext $FCFLAGS $LDFLAGS $ac_fcflags_srcext conftest.$ac_ext $LIBS >&5' -ac_compiler_gnu=$ac_cv_fc_compiler_gnu -if test -n "$ac_tool_prefix"; then - for ac_prog in gfortran g95 xlf95 f95 fort ifort ifc efc pgfortran pgf95 lf95 ftn nagfor xlf90 f90 pgf90 pghpf epcf90 g77 xlf f77 frt pgf77 cf77 fort77 fl32 af77 - do - # Extract the first word of "$ac_tool_prefix$ac_prog", so it can be a program name with args. -set dummy $ac_tool_prefix$ac_prog; ac_word=$2 -{ $as_echo "$as_me:${as_lineno-$LINENO}: checking for $ac_word" >&5 -$as_echo_n "checking for $ac_word... " >&6; } -if ${ac_cv_prog_FC+:} false; then : - $as_echo_n "(cached) " >&6 -else - if test -n "$FC"; then - ac_cv_prog_FC="$FC" # Let the user override the test. -else -as_save_IFS=$IFS; IFS=$PATH_SEPARATOR -for as_dir in $PATH -do - IFS=$as_save_IFS - test -z "$as_dir" && as_dir=. - for ac_exec_ext in '' $ac_executable_extensions; do - if as_fn_executable_p "$as_dir/$ac_word$ac_exec_ext"; then - ac_cv_prog_FC="$ac_tool_prefix$ac_prog" - $as_echo "$as_me:${as_lineno-$LINENO}: found $as_dir/$ac_word$ac_exec_ext" >&5 - break 2 - fi -done - done -IFS=$as_save_IFS - -fi -fi -FC=$ac_cv_prog_FC -if test -n "$FC"; then - { $as_echo "$as_me:${as_lineno-$LINENO}: result: $FC" >&5 -$as_echo "$FC" >&6; } -else - { $as_echo "$as_me:${as_lineno-$LINENO}: result: no" >&5 -$as_echo "no" >&6; } -fi - - - test -n "$FC" && break - done -fi -if test -z "$FC"; then - ac_ct_FC=$FC - for ac_prog in gfortran g95 xlf95 f95 fort ifort ifc efc pgfortran pgf95 lf95 ftn nagfor xlf90 f90 pgf90 pghpf epcf90 g77 xlf f77 frt pgf77 cf77 fort77 fl32 af77 -do - # Extract the first word of "$ac_prog", so it can be a program name with args. -set dummy $ac_prog; ac_word=$2 -{ $as_echo "$as_me:${as_lineno-$LINENO}: checking for $ac_word" >&5 -$as_echo_n "checking for $ac_word... " >&6; } -if ${ac_cv_prog_ac_ct_FC+:} false; then : - $as_echo_n "(cached) " >&6 -else - if test -n "$ac_ct_FC"; then - ac_cv_prog_ac_ct_FC="$ac_ct_FC" # Let the user override the test. -else -as_save_IFS=$IFS; IFS=$PATH_SEPARATOR -for as_dir in $PATH -do - IFS=$as_save_IFS - test -z "$as_dir" && as_dir=. - for ac_exec_ext in '' $ac_executable_extensions; do - if as_fn_executable_p "$as_dir/$ac_word$ac_exec_ext"; then - ac_cv_prog_ac_ct_FC="$ac_prog" - $as_echo "$as_me:${as_lineno-$LINENO}: found $as_dir/$ac_word$ac_exec_ext" >&5 - break 2 - fi -done - done -IFS=$as_save_IFS - -fi -fi -ac_ct_FC=$ac_cv_prog_ac_ct_FC -if test -n "$ac_ct_FC"; then - { $as_echo "$as_me:${as_lineno-$LINENO}: result: $ac_ct_FC" >&5 -$as_echo "$ac_ct_FC" >&6; } -else - { $as_echo "$as_me:${as_lineno-$LINENO}: result: no" >&5 -$as_echo "no" >&6; } -fi - - - test -n "$ac_ct_FC" && break -done - - if test "x$ac_ct_FC" = x; then - FC="" - else - case $cross_compiling:$ac_tool_warned in -yes:) -{ $as_echo "$as_me:${as_lineno-$LINENO}: WARNING: using cross tools not prefixed with host triplet" >&5 -$as_echo "$as_me: WARNING: using cross tools not prefixed with host triplet" >&2;} -ac_tool_warned=yes ;; -esac - FC=$ac_ct_FC - fi -fi - - -# Provide some information about the compiler. -$as_echo "$as_me:${as_lineno-$LINENO}: checking for Fortran compiler version" >&5 -set X $ac_compile -ac_compiler=$2 -for ac_option in --version -v -V -qversion; do - { { ac_try="$ac_compiler $ac_option >&5" -case "(($ac_try" in - *\"* | *\`* | *\\*) ac_try_echo=\$ac_try;; - *) ac_try_echo=$ac_try;; -esac -eval ac_try_echo="\"\$as_me:${as_lineno-$LINENO}: $ac_try_echo\"" -$as_echo "$ac_try_echo"; } >&5 - (eval "$ac_compiler $ac_option >&5") 2>conftest.err - ac_status=$? - if test -s conftest.err; then - sed '10a\ -... rest of stderr output deleted ... - 10q' conftest.err >conftest.er1 - cat conftest.er1 >&5 - fi - rm -f conftest.er1 conftest.err - $as_echo "$as_me:${as_lineno-$LINENO}: \$? = $ac_status" >&5 - test $ac_status = 0; } -done -rm -f a.out - -# If we don't use `.F' as extension, the preprocessor is not run on the -# input file. (Note that this only needs to work for GNU compilers.) -ac_save_ext=$ac_ext -ac_ext=F -{ $as_echo "$as_me:${as_lineno-$LINENO}: checking whether we are using the GNU Fortran compiler" >&5 -$as_echo_n "checking whether we are using the GNU Fortran compiler... " >&6; } -if ${ac_cv_fc_compiler_gnu+:} false; then : - $as_echo_n "(cached) " >&6 -else - cat > conftest.$ac_ext <<_ACEOF - program main -#ifndef __GNUC__ - choke me -#endif - - end -_ACEOF -if ac_fn_fc_try_compile "$LINENO"; then : - ac_compiler_gnu=yes -else - ac_compiler_gnu=no -fi -rm -f core conftest.err conftest.$ac_objext conftest.$ac_ext -ac_cv_fc_compiler_gnu=$ac_compiler_gnu - -fi -{ $as_echo "$as_me:${as_lineno-$LINENO}: result: $ac_cv_fc_compiler_gnu" >&5 -$as_echo "$ac_cv_fc_compiler_gnu" >&6; } -ac_ext=$ac_save_ext -ac_test_FCFLAGS=${FCFLAGS+set} -ac_save_FCFLAGS=$FCFLAGS -FCFLAGS= -{ $as_echo "$as_me:${as_lineno-$LINENO}: checking whether $FC accepts -g" >&5 -$as_echo_n "checking whether $FC accepts -g... " >&6; } -if ${ac_cv_prog_fc_g+:} false; then : - $as_echo_n "(cached) " >&6 -else - FCFLAGS=-g -cat > conftest.$ac_ext <<_ACEOF - program main - - end -_ACEOF -if ac_fn_fc_try_compile "$LINENO"; then : - ac_cv_prog_fc_g=yes -else - ac_cv_prog_fc_g=no -fi -rm -f core conftest.err conftest.$ac_objext conftest.$ac_ext - -fi -{ $as_echo "$as_me:${as_lineno-$LINENO}: result: $ac_cv_prog_fc_g" >&5 -$as_echo "$ac_cv_prog_fc_g" >&6; } -if test "$ac_test_FCFLAGS" = set; then - FCFLAGS=$ac_save_FCFLAGS -elif test $ac_cv_prog_fc_g = yes; then - if test "x$ac_cv_fc_compiler_gnu" = xyes; then - FCFLAGS="-g -O2" - else - FCFLAGS="-g" - fi -else - if test "x$ac_cv_fc_compiler_gnu" = xyes; then - FCFLAGS="-O2" - else - FCFLAGS= - fi -fi - -if test $ac_compiler_gnu = yes; then - GFC=yes -else - GFC= -fi -ac_ext=c -ac_cpp='$CPP $CPPFLAGS' -ac_compile='$CC -c $CFLAGS $CPPFLAGS conftest.$ac_ext >&5' -ac_link='$CC -o conftest$ac_exeext $CFLAGS $CPPFLAGS $LDFLAGS conftest.$ac_ext $LIBS >&5' -ac_compiler_gnu=$ac_cv_c_compiler_gnu - -if test -n "$ac_tool_prefix"; then - # Extract the first word of "${ac_tool_prefix}ranlib", so it can be a program name with args. -set dummy ${ac_tool_prefix}ranlib; ac_word=$2 -{ $as_echo "$as_me:${as_lineno-$LINENO}: checking for $ac_word" >&5 -$as_echo_n "checking for $ac_word... " >&6; } -if ${ac_cv_prog_RANLIB+:} false; then : - $as_echo_n "(cached) " >&6 -else - if test -n "$RANLIB"; then - ac_cv_prog_RANLIB="$RANLIB" # Let the user override the test. -else -as_save_IFS=$IFS; IFS=$PATH_SEPARATOR -for as_dir in $PATH -do - IFS=$as_save_IFS - test -z "$as_dir" && as_dir=. - for ac_exec_ext in '' $ac_executable_extensions; do - if as_fn_executable_p "$as_dir/$ac_word$ac_exec_ext"; then - ac_cv_prog_RANLIB="${ac_tool_prefix}ranlib" - $as_echo "$as_me:${as_lineno-$LINENO}: found $as_dir/$ac_word$ac_exec_ext" >&5 - break 2 - fi -done - done -IFS=$as_save_IFS - -fi -fi -RANLIB=$ac_cv_prog_RANLIB -if test -n "$RANLIB"; then - { $as_echo "$as_me:${as_lineno-$LINENO}: result: $RANLIB" >&5 -$as_echo "$RANLIB" >&6; } -else - { $as_echo "$as_me:${as_lineno-$LINENO}: result: no" >&5 -$as_echo "no" >&6; } -fi - - -fi -if test -z "$ac_cv_prog_RANLIB"; then - ac_ct_RANLIB=$RANLIB - # Extract the first word of "ranlib", so it can be a program name with args. -set dummy ranlib; ac_word=$2 -{ $as_echo "$as_me:${as_lineno-$LINENO}: checking for $ac_word" >&5 -$as_echo_n "checking for $ac_word... " >&6; } -if ${ac_cv_prog_ac_ct_RANLIB+:} false; then : - $as_echo_n "(cached) " >&6 -else - if test -n "$ac_ct_RANLIB"; then - ac_cv_prog_ac_ct_RANLIB="$ac_ct_RANLIB" # Let the user override the test. -else -as_save_IFS=$IFS; IFS=$PATH_SEPARATOR -for as_dir in $PATH -do - IFS=$as_save_IFS - test -z "$as_dir" && as_dir=. - for ac_exec_ext in '' $ac_executable_extensions; do - if as_fn_executable_p "$as_dir/$ac_word$ac_exec_ext"; then - ac_cv_prog_ac_ct_RANLIB="ranlib" - $as_echo "$as_me:${as_lineno-$LINENO}: found $as_dir/$ac_word$ac_exec_ext" >&5 - break 2 - fi -done - done -IFS=$as_save_IFS - -fi -fi -ac_ct_RANLIB=$ac_cv_prog_ac_ct_RANLIB -if test -n "$ac_ct_RANLIB"; then - { $as_echo "$as_me:${as_lineno-$LINENO}: result: $ac_ct_RANLIB" >&5 -$as_echo "$ac_ct_RANLIB" >&6; } -else - { $as_echo "$as_me:${as_lineno-$LINENO}: result: no" >&5 -$as_echo "no" >&6; } -fi - - if test "x$ac_ct_RANLIB" = x; then - RANLIB=":" - else - case $cross_compiling:$ac_tool_warned in -yes:) -{ $as_echo "$as_me:${as_lineno-$LINENO}: WARNING: using cross tools not prefixed with host triplet" >&5 -$as_echo "$as_me: WARNING: using cross tools not prefixed with host triplet" >&2;} -ac_tool_warned=yes ;; -esac - RANLIB=$ac_ct_RANLIB - fi -else - RANLIB="$ac_cv_prog_RANLIB" -fi - - -{ $as_echo "$as_me:${as_lineno-$LINENO}: checking whether ln -s works" >&5 -$as_echo_n "checking whether ln -s works... " >&6; } -LN_S=$as_ln_s -if test "$LN_S" = "ln -s"; then - { $as_echo "$as_me:${as_lineno-$LINENO}: result: yes" >&5 -$as_echo "yes" >&6; } -else - { $as_echo "$as_me:${as_lineno-$LINENO}: result: no, using $LN_S" >&5 -$as_echo "no, using $LN_S" >&6; } -fi - -{ $as_echo "$as_me:${as_lineno-$LINENO}: checking whether ${MAKE-make} sets \$(MAKE)" >&5 -$as_echo_n "checking whether ${MAKE-make} sets \$(MAKE)... " >&6; } -set x ${MAKE-make} -ac_make=`$as_echo "$2" | sed 's/+/p/g; s/[^a-zA-Z0-9_]/_/g'` -if eval \${ac_cv_prog_make_${ac_make}_set+:} false; then : - $as_echo_n "(cached) " >&6 -else - cat >conftest.make <<\_ACEOF -SHELL = /bin/sh -all: - @echo '@@@%%%=$(MAKE)=@@@%%%' -_ACEOF -# GNU make sometimes prints "make[1]: Entering ...", which would confuse us. -case `${MAKE-make} -f conftest.make 2>/dev/null` in - *@@@%%%=?*=@@@%%%*) - eval ac_cv_prog_make_${ac_make}_set=yes;; - *) - eval ac_cv_prog_make_${ac_make}_set=no;; -esac -rm -f conftest.make -fi -if eval test \$ac_cv_prog_make_${ac_make}_set = yes; then - { $as_echo "$as_me:${as_lineno-$LINENO}: result: yes" >&5 -$as_echo "yes" >&6; } - SET_MAKE= -else - { $as_echo "$as_me:${as_lineno-$LINENO}: result: no" >&5 -$as_echo "no" >&6; } - SET_MAKE="MAKE=${MAKE-make}" -fi - - - - -{ $as_echo "$as_me:${as_lineno-$LINENO}: checking for grep that handles long lines and -e" >&5 -$as_echo_n "checking for grep that handles long lines and -e... " >&6; } -if ${ac_cv_path_GREP+:} false; then : - $as_echo_n "(cached) " >&6 -else - if test -z "$GREP"; then - ac_path_GREP_found=false - # Loop through the user's path and test for each of PROGNAME-LIST - as_save_IFS=$IFS; IFS=$PATH_SEPARATOR -for as_dir in $PATH$PATH_SEPARATOR/usr/xpg4/bin -do - IFS=$as_save_IFS - test -z "$as_dir" && as_dir=. - for ac_prog in grep ggrep; do - for ac_exec_ext in '' $ac_executable_extensions; do - ac_path_GREP="$as_dir/$ac_prog$ac_exec_ext" - as_fn_executable_p "$ac_path_GREP" || continue -# Check for GNU ac_path_GREP and select it if it is found. - # Check for GNU $ac_path_GREP -case `"$ac_path_GREP" --version 2>&1` in -*GNU*) - ac_cv_path_GREP="$ac_path_GREP" ac_path_GREP_found=:;; -*) - ac_count=0 - $as_echo_n 0123456789 >"conftest.in" - while : - do - cat "conftest.in" "conftest.in" >"conftest.tmp" - mv "conftest.tmp" "conftest.in" - cp "conftest.in" "conftest.nl" - $as_echo 'GREP' >> "conftest.nl" - "$ac_path_GREP" -e 'GREP$' -e '-(cannot match)-' < "conftest.nl" >"conftest.out" 2>/dev/null || break - diff "conftest.out" "conftest.nl" >/dev/null 2>&1 || break - as_fn_arith $ac_count + 1 && ac_count=$as_val - if test $ac_count -gt ${ac_path_GREP_max-0}; then - # Best one so far, save it but keep looking for a better one - ac_cv_path_GREP="$ac_path_GREP" - ac_path_GREP_max=$ac_count - fi - # 10*(2^10) chars as input seems more than enough - test $ac_count -gt 10 && break - done - rm -f conftest.in conftest.tmp conftest.nl conftest.out;; -esac - - $ac_path_GREP_found && break 3 - done - done - done -IFS=$as_save_IFS - if test -z "$ac_cv_path_GREP"; then - as_fn_error $? "no acceptable grep could be found in $PATH$PATH_SEPARATOR/usr/xpg4/bin" "$LINENO" 5 - fi -else - ac_cv_path_GREP=$GREP -fi - -fi -{ $as_echo "$as_me:${as_lineno-$LINENO}: result: $ac_cv_path_GREP" >&5 -$as_echo "$ac_cv_path_GREP" >&6; } - GREP="$ac_cv_path_GREP" - - -{ $as_echo "$as_me:${as_lineno-$LINENO}: checking for egrep" >&5 -$as_echo_n "checking for egrep... " >&6; } -if ${ac_cv_path_EGREP+:} false; then : - $as_echo_n "(cached) " >&6 -else - if echo a | $GREP -E '(a|b)' >/dev/null 2>&1 - then ac_cv_path_EGREP="$GREP -E" - else - if test -z "$EGREP"; then - ac_path_EGREP_found=false - # Loop through the user's path and test for each of PROGNAME-LIST - as_save_IFS=$IFS; IFS=$PATH_SEPARATOR -for as_dir in $PATH$PATH_SEPARATOR/usr/xpg4/bin -do - IFS=$as_save_IFS - test -z "$as_dir" && as_dir=. - for ac_prog in egrep; do - for ac_exec_ext in '' $ac_executable_extensions; do - ac_path_EGREP="$as_dir/$ac_prog$ac_exec_ext" - as_fn_executable_p "$ac_path_EGREP" || continue -# Check for GNU ac_path_EGREP and select it if it is found. - # Check for GNU $ac_path_EGREP -case `"$ac_path_EGREP" --version 2>&1` in -*GNU*) - ac_cv_path_EGREP="$ac_path_EGREP" ac_path_EGREP_found=:;; -*) - ac_count=0 - $as_echo_n 0123456789 >"conftest.in" - while : - do - cat "conftest.in" "conftest.in" >"conftest.tmp" - mv "conftest.tmp" "conftest.in" - cp "conftest.in" "conftest.nl" - $as_echo 'EGREP' >> "conftest.nl" - "$ac_path_EGREP" 'EGREP$' < "conftest.nl" >"conftest.out" 2>/dev/null || break - diff "conftest.out" "conftest.nl" >/dev/null 2>&1 || break - as_fn_arith $ac_count + 1 && ac_count=$as_val - if test $ac_count -gt ${ac_path_EGREP_max-0}; then - # Best one so far, save it but keep looking for a better one - ac_cv_path_EGREP="$ac_path_EGREP" - ac_path_EGREP_max=$ac_count - fi - # 10*(2^10) chars as input seems more than enough - test $ac_count -gt 10 && break - done - rm -f conftest.in conftest.tmp conftest.nl conftest.out;; -esac - - $ac_path_EGREP_found && break 3 - done - done - done -IFS=$as_save_IFS - if test -z "$ac_cv_path_EGREP"; then - as_fn_error $? "no acceptable egrep could be found in $PATH$PATH_SEPARATOR/usr/xpg4/bin" "$LINENO" 5 - fi -else - ac_cv_path_EGREP=$EGREP -fi - - fi -fi -{ $as_echo "$as_me:${as_lineno-$LINENO}: result: $ac_cv_path_EGREP" >&5 -$as_echo "$ac_cv_path_EGREP" >&6; } - EGREP="$ac_cv_path_EGREP" - - -{ $as_echo "$as_me:${as_lineno-$LINENO}: checking for ANSI C header files" >&5 -$as_echo_n "checking for ANSI C header files... " >&6; } -if ${ac_cv_header_stdc+:} false; then : - $as_echo_n "(cached) " >&6 -else - cat confdefs.h - <<_ACEOF >conftest.$ac_ext -/* end confdefs.h. */ -#include -#include -#include -#include - -int -main () -{ - - ; - return 0; -} -_ACEOF -if ac_fn_c_try_compile "$LINENO"; then : - ac_cv_header_stdc=yes -else - ac_cv_header_stdc=no -fi -rm -f core conftest.err conftest.$ac_objext conftest.$ac_ext - -if test $ac_cv_header_stdc = yes; then - # SunOS 4.x string.h does not declare mem*, contrary to ANSI. - cat confdefs.h - <<_ACEOF >conftest.$ac_ext -/* end confdefs.h. */ -#include - -_ACEOF -if (eval "$ac_cpp conftest.$ac_ext") 2>&5 | - $EGREP "memchr" >/dev/null 2>&1; then : - -else - ac_cv_header_stdc=no -fi -rm -f conftest* - -fi - -if test $ac_cv_header_stdc = yes; then - # ISC 2.0.2 stdlib.h does not declare free, contrary to ANSI. - cat confdefs.h - <<_ACEOF >conftest.$ac_ext -/* end confdefs.h. */ -#include - -_ACEOF -if (eval "$ac_cpp conftest.$ac_ext") 2>&5 | - $EGREP "free" >/dev/null 2>&1; then : - -else - ac_cv_header_stdc=no -fi -rm -f conftest* - -fi - -if test $ac_cv_header_stdc = yes; then - # /bin/cc in Irix-4.0.5 gets non-ANSI ctype macros unless using -ansi. - if test "$cross_compiling" = yes; then : - : -else - cat confdefs.h - <<_ACEOF >conftest.$ac_ext -/* end confdefs.h. */ -#include -#include -#if ((' ' & 0x0FF) == 0x020) -# define ISLOWER(c) ('a' <= (c) && (c) <= 'z') -# define TOUPPER(c) (ISLOWER(c) ? 'A' + ((c) - 'a') : (c)) -#else -# define ISLOWER(c) \ - (('a' <= (c) && (c) <= 'i') \ - || ('j' <= (c) && (c) <= 'r') \ - || ('s' <= (c) && (c) <= 'z')) -# define TOUPPER(c) (ISLOWER(c) ? ((c) | 0x40) : (c)) -#endif - -#define XOR(e, f) (((e) && !(f)) || (!(e) && (f))) -int -main () -{ - int i; - for (i = 0; i < 256; i++) - if (XOR (islower (i), ISLOWER (i)) - || toupper (i) != TOUPPER (i)) - return 2; - return 0; -} -_ACEOF -if ac_fn_c_try_run "$LINENO"; then : - -else - ac_cv_header_stdc=no -fi -rm -f core *.core core.conftest.* gmon.out bb.out conftest$ac_exeext \ - conftest.$ac_objext conftest.beam conftest.$ac_ext -fi - -fi -fi -{ $as_echo "$as_me:${as_lineno-$LINENO}: result: $ac_cv_header_stdc" >&5 -$as_echo "$ac_cv_header_stdc" >&6; } -if test $ac_cv_header_stdc = yes; then - -$as_echo "@%:@define STDC_HEADERS 1" >>confdefs.h - -fi - - -# On IRIX 5.3, sys/types and inttypes.h are conflicting. -for ac_header in sys/types.h sys/stat.h stdlib.h string.h memory.h strings.h \ - inttypes.h stdint.h unistd.h -do : - as_ac_Header=`$as_echo "ac_cv_header_$ac_header" | $as_tr_sh` -ac_fn_c_check_header_compile "$LINENO" "$ac_header" "$as_ac_Header" "$ac_includes_default -" -if eval test \"x\$"$as_ac_Header"\" = x"yes"; then : - cat >>confdefs.h <<_ACEOF -@%:@define `$as_echo "HAVE_$ac_header" | $as_tr_cpp` 1 -_ACEOF - -fi - -done - - -ac_fn_c_check_type "$LINENO" "size_t" "ac_cv_type_size_t" "$ac_includes_default" -if test "x$ac_cv_type_size_t" = xyes; then : - -else - -cat >>confdefs.h <<_ACEOF -@%:@define size_t unsigned int -_ACEOF - -fi - -{ $as_echo "$as_me:${as_lineno-$LINENO}: checking whether struct tm is in sys/time.h or time.h" >&5 -$as_echo_n "checking whether struct tm is in sys/time.h or time.h... " >&6; } -if ${ac_cv_struct_tm+:} false; then : - $as_echo_n "(cached) " >&6 -else - cat confdefs.h - <<_ACEOF >conftest.$ac_ext -/* end confdefs.h. */ -#include -#include - -int -main () -{ -struct tm tm; - int *p = &tm.tm_sec; - return !p; - ; - return 0; -} -_ACEOF -if ac_fn_c_try_compile "$LINENO"; then : - ac_cv_struct_tm=time.h -else - ac_cv_struct_tm=sys/time.h -fi -rm -f core conftest.err conftest.$ac_objext conftest.$ac_ext -fi -{ $as_echo "$as_me:${as_lineno-$LINENO}: result: $ac_cv_struct_tm" >&5 -$as_echo "$ac_cv_struct_tm" >&6; } -if test $ac_cv_struct_tm = sys/time.h; then - -$as_echo "@%:@define TM_IN_SYS_TIME 1" >>confdefs.h - -fi - -{ $as_echo "$as_me:${as_lineno-$LINENO}: checking for an ANSI C-conforming const" >&5 -$as_echo_n "checking for an ANSI C-conforming const... " >&6; } -if ${ac_cv_c_const+:} false; then : - $as_echo_n "(cached) " >&6 -else - cat confdefs.h - <<_ACEOF >conftest.$ac_ext -/* end confdefs.h. */ - -int -main () -{ - -#ifndef __cplusplus - /* Ultrix mips cc rejects this sort of thing. */ - typedef int charset[2]; - const charset cs = { 0, 0 }; - /* SunOS 4.1.1 cc rejects this. */ - char const *const *pcpcc; - char **ppc; - /* NEC SVR4.0.2 mips cc rejects this. */ - struct point {int x, y;}; - static struct point const zero = {0,0}; - /* AIX XL C 1.02.0.0 rejects this. - It does not let you subtract one const X* pointer from another in - an arm of an if-expression whose if-part is not a constant - expression */ - const char *g = "string"; - pcpcc = &g + (g ? g-g : 0); - /* HPUX 7.0 cc rejects these. */ - ++pcpcc; - ppc = (char**) pcpcc; - pcpcc = (char const *const *) ppc; - { /* SCO 3.2v4 cc rejects this sort of thing. */ - char tx; - char *t = &tx; - char const *s = 0 ? (char *) 0 : (char const *) 0; - - *t++ = 0; - if (s) return 0; - } - { /* Someone thinks the Sun supposedly-ANSI compiler will reject this. */ - int x[] = {25, 17}; - const int *foo = &x[0]; - ++foo; - } - { /* Sun SC1.0 ANSI compiler rejects this -- but not the above. */ - typedef const int *iptr; - iptr p = 0; - ++p; - } - { /* AIX XL C 1.02.0.0 rejects this sort of thing, saying - "k.c", line 2.27: 1506-025 (S) Operand must be a modifiable lvalue. */ - struct s { int j; const int *ap[3]; } bx; - struct s *b = &bx; b->j = 5; - } - { /* ULTRIX-32 V3.1 (Rev 9) vcc rejects this */ - const int foo = 10; - if (!foo) return 0; - } - return !cs[0] && !zero.x; -#endif - - ; - return 0; -} -_ACEOF -if ac_fn_c_try_compile "$LINENO"; then : - ac_cv_c_const=yes -else - ac_cv_c_const=no -fi -rm -f core conftest.err conftest.$ac_objext conftest.$ac_ext -fi -{ $as_echo "$as_me:${as_lineno-$LINENO}: result: $ac_cv_c_const" >&5 -$as_echo "$ac_cv_c_const" >&6; } -if test $ac_cv_c_const = no; then - -$as_echo "@%:@define const /**/" >>confdefs.h - -fi - -for ac_header in stdlib.h -do : - ac_fn_c_check_header_mongrel "$LINENO" "stdlib.h" "ac_cv_header_stdlib_h" "$ac_includes_default" -if test "x$ac_cv_header_stdlib_h" = xyes; then : - cat >>confdefs.h <<_ACEOF -@%:@define HAVE_STDLIB_H 1 -_ACEOF - -fi - -done - -{ $as_echo "$as_me:${as_lineno-$LINENO}: checking for GNU libc compatible malloc" >&5 -$as_echo_n "checking for GNU libc compatible malloc... " >&6; } -if ${ac_cv_func_malloc_0_nonnull+:} false; then : - $as_echo_n "(cached) " >&6 -else - if test "$cross_compiling" = yes; then : - ac_cv_func_malloc_0_nonnull=no -else - cat confdefs.h - <<_ACEOF >conftest.$ac_ext -/* end confdefs.h. */ -#if defined STDC_HEADERS || defined HAVE_STDLIB_H -# include -#else -char *malloc (); -#endif - -int -main () -{ -return ! malloc (0); - ; - return 0; -} -_ACEOF -if ac_fn_c_try_run "$LINENO"; then : - ac_cv_func_malloc_0_nonnull=yes -else - ac_cv_func_malloc_0_nonnull=no -fi -rm -f core *.core core.conftest.* gmon.out bb.out conftest$ac_exeext \ - conftest.$ac_objext conftest.beam conftest.$ac_ext -fi - -fi -{ $as_echo "$as_me:${as_lineno-$LINENO}: result: $ac_cv_func_malloc_0_nonnull" >&5 -$as_echo "$ac_cv_func_malloc_0_nonnull" >&6; } -if test $ac_cv_func_malloc_0_nonnull = yes; then : - -$as_echo "@%:@define HAVE_MALLOC 1" >>confdefs.h - -else - $as_echo "@%:@define HAVE_MALLOC 0" >>confdefs.h - - case " $LIB@&t@OBJS " in - *" malloc.$ac_objext "* ) ;; - *) LIB@&t@OBJS="$LIB@&t@OBJS malloc.$ac_objext" - ;; -esac - - -$as_echo "@%:@define malloc rpl_malloc" >>confdefs.h - -fi - - - - - -{ $as_echo "$as_me:${as_lineno-$LINENO}: checking Fortran 90 module inclusion flag" >&5 -$as_echo_n "checking Fortran 90 module inclusion flag... " >&6; } -if ${ac_cv_fc_module_flag+:} false; then : - $as_echo_n "(cached) " >&6 -else - ac_ext=${ac_fc_srcext-f} -ac_compile='$FC -c $FCFLAGS $ac_fcflags_srcext conftest.$ac_ext >&5' -ac_link='$FC -o conftest$ac_exeext $FCFLAGS $LDFLAGS $ac_fcflags_srcext conftest.$ac_ext $LIBS >&5' -ac_compiler_gnu=$ac_cv_fc_compiler_gnu - -ac_cv_fc_module_flag=unknown -mkdir conftest.dir -cd conftest.dir -cat > conftest.$ac_ext <<_ACEOF - - module conftest_module - contains - subroutine conftest_routine - write(*,'(a)') 'gotcha!' - end subroutine - end module -_ACEOF -if ac_fn_fc_try_compile "$LINENO"; then : - cd .. - ac_fc_module_flag_FCFLAGS_save=$FCFLAGS - # Flag ordering is significant for gfortran and Sun. - for ac_flag in -M -I '-I ' '-M ' -p '-mod ' '-module ' '-Am -I'; do - # Add the flag twice to prevent matching an output flag. - FCFLAGS="$ac_fc_module_flag_FCFLAGS_save ${ac_flag}conftest.dir ${ac_flag}conftest.dir" - cat > conftest.$ac_ext <<_ACEOF - - program main - use conftest_module - call conftest_routine - end program -_ACEOF -if ac_fn_fc_try_compile "$LINENO"; then : - ac_cv_fc_module_flag="$ac_flag" -fi -rm -f core conftest.err conftest.$ac_objext conftest.$ac_ext - if test "$ac_cv_fc_module_flag" != unknown; then - break - fi - done - FCFLAGS=$ac_fc_module_flag_FCFLAGS_save - -fi -rm -f core conftest.err conftest.$ac_objext conftest.$ac_ext -rm -rf conftest.dir -ac_ext=c -ac_cpp='$CPP $CPPFLAGS' -ac_compile='$CC -c $CFLAGS $CPPFLAGS conftest.$ac_ext >&5' -ac_link='$CC -o conftest$ac_exeext $CFLAGS $CPPFLAGS $LDFLAGS conftest.$ac_ext $LIBS >&5' -ac_compiler_gnu=$ac_cv_c_compiler_gnu - - -fi -{ $as_echo "$as_me:${as_lineno-$LINENO}: result: $ac_cv_fc_module_flag" >&5 -$as_echo "$ac_cv_fc_module_flag" >&6; } -if test "$ac_cv_fc_module_flag" != unknown; then - FC_MODINC=$ac_cv_fc_module_flag - -else - FC_MODINC= - as_fn_error $? "unable to find compiler flag for module search path" "$LINENO" 5 -fi - -# Ensure trailing whitespace is preserved in a Makefile. -ac_empty="" - - - -{ $as_echo "$as_me:${as_lineno-$LINENO}: checking Fortran 90 module output flag" >&5 -$as_echo_n "checking Fortran 90 module output flag... " >&6; } -if ${ac_cv_fc_module_output_flag+:} false; then : - $as_echo_n "(cached) " >&6 -else - ac_ext=${ac_fc_srcext-f} -ac_compile='$FC -c $FCFLAGS $ac_fcflags_srcext conftest.$ac_ext >&5' -ac_link='$FC -o conftest$ac_exeext $FCFLAGS $LDFLAGS $ac_fcflags_srcext conftest.$ac_ext $LIBS >&5' -ac_compiler_gnu=$ac_cv_fc_compiler_gnu - -mkdir conftest.dir conftest.dir/sub -cd conftest.dir -ac_cv_fc_module_output_flag=unknown -ac_fc_module_output_flag_FCFLAGS_save=$FCFLAGS -# Flag ordering is significant: put flags late which some compilers use -# for the search path. -for ac_flag in -J '-J ' -fmod= -moddir= +moddir= -qmoddir= '-mod ' \ - '-module ' -M '-Am -M' '-e m -J '; do - FCFLAGS="$ac_fc_module_output_flag_FCFLAGS_save ${ac_flag}sub" - cat > conftest.$ac_ext <<_ACEOF - - module conftest_module - contains - subroutine conftest_routine - write(*,'(a)') 'gotcha!' - end subroutine - end module -_ACEOF -if ac_fn_fc_try_compile "$LINENO"; then : - cd sub - cat > conftest.$ac_ext <<_ACEOF - - program main - use conftest_module - call conftest_routine - end program -_ACEOF -if ac_fn_fc_try_compile "$LINENO"; then : - ac_cv_fc_module_output_flag="$ac_flag" -fi -rm -f core conftest.err conftest.$ac_objext conftest.$ac_ext - cd .. - if test "$ac_cv_fc_module_output_flag" != unknown; then - break - fi -fi -rm -f core conftest.err conftest.$ac_objext conftest.$ac_ext -done -FCFLAGS=$ac_fc_module_output_flag_FCFLAGS_save -cd .. -rm -rf conftest.dir -ac_ext=c -ac_cpp='$CPP $CPPFLAGS' -ac_compile='$CC -c $CFLAGS $CPPFLAGS conftest.$ac_ext >&5' -ac_link='$CC -o conftest$ac_exeext $CFLAGS $CPPFLAGS $LDFLAGS conftest.$ac_ext $LIBS >&5' -ac_compiler_gnu=$ac_cv_c_compiler_gnu - - -fi -{ $as_echo "$as_me:${as_lineno-$LINENO}: result: $ac_cv_fc_module_output_flag" >&5 -$as_echo "$ac_cv_fc_module_output_flag" >&6; } -if test "$ac_cv_fc_module_output_flag" != unknown; then - FC_MODOUT=$ac_cv_fc_module_output_flag - -else - FC_MODOUT= - as_fn_error $? "unable to find compiler flag to write module information to" "$LINENO" 5 -fi - -# Ensure trailing whitespace is preserved in a Makefile. -ac_empty="" - - -{ $as_echo "$as_me:${as_lineno-$LINENO}: checking Fortran 90 module extension" >&5 -$as_echo_n "checking Fortran 90 module extension... " >&6; } -if ${ac_cv_fc_module_ext+:} false; then : - $as_echo_n "(cached) " >&6 -else - ac_ext=${ac_fc_srcext-f} -ac_compile='$FC -c $FCFLAGS $ac_fcflags_srcext conftest.$ac_ext >&5' -ac_link='$FC -o conftest$ac_exeext $FCFLAGS $LDFLAGS $ac_fcflags_srcext conftest.$ac_ext $LIBS >&5' -ac_compiler_gnu=$ac_cv_fc_compiler_gnu - -mkdir conftest.dir -cd conftest.dir -ac_cv_fc_module_ext=unknown -cat > conftest.$ac_ext <<_ACEOF - - module conftest_module - contains - subroutine conftest_routine - write(*,'(a)') 'gotcha!' - end subroutine - end module -_ACEOF -if ac_fn_fc_try_compile "$LINENO"; then : - ac_cv_fc_module_ext=`ls | sed -n 's,conftest_module\.,,p'` - if test x$ac_cv_fc_module_ext = x; then - ac_cv_fc_module_ext=`ls | sed -n 's,CONFTEST_MODULE\.,,p'` - fi -fi -rm -f core conftest.err conftest.$ac_objext conftest.$ac_ext -cd .. -rm -rf conftest.dir -ac_ext=c -ac_cpp='$CPP $CPPFLAGS' -ac_compile='$CC -c $CFLAGS $CPPFLAGS conftest.$ac_ext >&5' -ac_link='$CC -o conftest$ac_exeext $CFLAGS $CPPFLAGS $LDFLAGS conftest.$ac_ext $LIBS >&5' -ac_compiler_gnu=$ac_cv_c_compiler_gnu - - -fi -{ $as_echo "$as_me:${as_lineno-$LINENO}: result: $ac_cv_fc_module_ext" >&5 -$as_echo "$ac_cv_fc_module_ext" >&6; } -FC_MODEXT=$ac_cv_fc_module_ext -if test "$FC_MODEXT" = unknown; then - FC_MODEXT= -fi - - - -case $build in - *solaris*) - CFITS_LIBS="-lnsl -lsocket" - ;; - *) - ;; -esac - -for ac_header in fitsio.h -do : - ac_fn_c_check_header_mongrel "$LINENO" "fitsio.h" "ac_cv_header_fitsio_h" "$ac_includes_default" -if test "x$ac_cv_header_fitsio_h" = xyes; then : - cat >>confdefs.h <<_ACEOF -@%:@define HAVE_FITSIO_H 1 -_ACEOF - -fi - -done - -{ $as_echo "$as_me:${as_lineno-$LINENO}: checking for ffclos in -lcfitsio" >&5 -$as_echo_n "checking for ffclos in -lcfitsio... " >&6; } -if ${ac_cv_lib_cfitsio_ffclos+:} false; then : - $as_echo_n "(cached) " >&6 -else - ac_check_lib_save_LIBS=$LIBS -LIBS="-lcfitsio $CFITS_LIBS -lm $LIBS" -cat confdefs.h - <<_ACEOF >conftest.$ac_ext -/* end confdefs.h. */ - -/* Override any GCC internal prototype to avoid an error. - Use char because int might match the return type of a GCC - builtin and then its argument prototype would still apply. */ -#ifdef __cplusplus -extern "C" -#endif -char ffclos (); -int -main () -{ -return ffclos (); - ; - return 0; -} -_ACEOF -if ac_fn_c_try_link "$LINENO"; then : - ac_cv_lib_cfitsio_ffclos=yes -else - ac_cv_lib_cfitsio_ffclos=no -fi -rm -f core conftest.err conftest.$ac_objext \ - conftest$ac_exeext conftest.$ac_ext -LIBS=$ac_check_lib_save_LIBS -fi -{ $as_echo "$as_me:${as_lineno-$LINENO}: result: $ac_cv_lib_cfitsio_ffclos" >&5 -$as_echo "$ac_cv_lib_cfitsio_ffclos" >&6; } -if test "x$ac_cv_lib_cfitsio_ffclos" = xyes; then : - LIBCFITSIO=-lcfitsio - -else - as_fn_error $? "cFITSIO library not found." "$LINENO" 5 -fi - - -{ $as_echo "$as_me:${as_lineno-$LINENO}: checking for lmder_ in -lminpack" >&5 -$as_echo_n "checking for lmder_ in -lminpack... " >&6; } -if ${ac_cv_lib_minpack_lmder_+:} false; then : - $as_echo_n "(cached) " >&6 -else - ac_check_lib_save_LIBS=$LIBS -LIBS="-lminpack $LIBS" -cat confdefs.h - <<_ACEOF >conftest.$ac_ext -/* end confdefs.h. */ - -/* Override any GCC internal prototype to avoid an error. - Use char because int might match the return type of a GCC - builtin and then its argument prototype would still apply. */ -#ifdef __cplusplus -extern "C" -#endif -char lmder_ (); -int -main () -{ -return lmder_ (); - ; - return 0; -} -_ACEOF -if ac_fn_c_try_link "$LINENO"; then : - ac_cv_lib_minpack_lmder_=yes -else - ac_cv_lib_minpack_lmder_=no -fi -rm -f core conftest.err conftest.$ac_objext \ - conftest$ac_exeext conftest.$ac_ext -LIBS=$ac_check_lib_save_LIBS -fi -{ $as_echo "$as_me:${as_lineno-$LINENO}: result: $ac_cv_lib_minpack_lmder_" >&5 -$as_echo "$ac_cv_lib_minpack_lmder_" >&6; } -if test "x$ac_cv_lib_minpack_lmder_" = xyes; then : - cat >>confdefs.h <<_ACEOF -@%:@define HAVE_LIBMINPACK 1 -_ACEOF - - LIBS="-lminpack $LIBS" - -else - - ac_ext=f -ac_compile='$F77 -c $FFLAGS conftest.$ac_ext >&5' -ac_link='$F77 -o conftest$ac_exeext $FFLAGS $LDFLAGS conftest.$ac_ext $LIBS >&5' -ac_compiler_gnu=$ac_cv_f77_compiler_gnu -if test -n "$ac_tool_prefix"; then - for ac_prog in g77 xlf f77 frt pgf77 cf77 fort77 fl32 af77 xlf90 f90 pgf90 pghpf epcf90 gfortran g95 xlf95 f95 fort ifort ifc efc pgfortran pgf95 lf95 ftn nagfor - do - # Extract the first word of "$ac_tool_prefix$ac_prog", so it can be a program name with args. -set dummy $ac_tool_prefix$ac_prog; ac_word=$2 -{ $as_echo "$as_me:${as_lineno-$LINENO}: checking for $ac_word" >&5 -$as_echo_n "checking for $ac_word... " >&6; } -if ${ac_cv_prog_F77+:} false; then : - $as_echo_n "(cached) " >&6 -else - if test -n "$F77"; then - ac_cv_prog_F77="$F77" # Let the user override the test. -else -as_save_IFS=$IFS; IFS=$PATH_SEPARATOR -for as_dir in $PATH -do - IFS=$as_save_IFS - test -z "$as_dir" && as_dir=. - for ac_exec_ext in '' $ac_executable_extensions; do - if as_fn_executable_p "$as_dir/$ac_word$ac_exec_ext"; then - ac_cv_prog_F77="$ac_tool_prefix$ac_prog" - $as_echo "$as_me:${as_lineno-$LINENO}: found $as_dir/$ac_word$ac_exec_ext" >&5 - break 2 - fi -done - done -IFS=$as_save_IFS - -fi -fi -F77=$ac_cv_prog_F77 -if test -n "$F77"; then - { $as_echo "$as_me:${as_lineno-$LINENO}: result: $F77" >&5 -$as_echo "$F77" >&6; } -else - { $as_echo "$as_me:${as_lineno-$LINENO}: result: no" >&5 -$as_echo "no" >&6; } -fi - - - test -n "$F77" && break - done -fi -if test -z "$F77"; then - ac_ct_F77=$F77 - for ac_prog in g77 xlf f77 frt pgf77 cf77 fort77 fl32 af77 xlf90 f90 pgf90 pghpf epcf90 gfortran g95 xlf95 f95 fort ifort ifc efc pgfortran pgf95 lf95 ftn nagfor -do - # Extract the first word of "$ac_prog", so it can be a program name with args. -set dummy $ac_prog; ac_word=$2 -{ $as_echo "$as_me:${as_lineno-$LINENO}: checking for $ac_word" >&5 -$as_echo_n "checking for $ac_word... " >&6; } -if ${ac_cv_prog_ac_ct_F77+:} false; then : - $as_echo_n "(cached) " >&6 -else - if test -n "$ac_ct_F77"; then - ac_cv_prog_ac_ct_F77="$ac_ct_F77" # Let the user override the test. -else -as_save_IFS=$IFS; IFS=$PATH_SEPARATOR -for as_dir in $PATH -do - IFS=$as_save_IFS - test -z "$as_dir" && as_dir=. - for ac_exec_ext in '' $ac_executable_extensions; do - if as_fn_executable_p "$as_dir/$ac_word$ac_exec_ext"; then - ac_cv_prog_ac_ct_F77="$ac_prog" - $as_echo "$as_me:${as_lineno-$LINENO}: found $as_dir/$ac_word$ac_exec_ext" >&5 - break 2 - fi -done - done -IFS=$as_save_IFS - -fi -fi -ac_ct_F77=$ac_cv_prog_ac_ct_F77 -if test -n "$ac_ct_F77"; then - { $as_echo "$as_me:${as_lineno-$LINENO}: result: $ac_ct_F77" >&5 -$as_echo "$ac_ct_F77" >&6; } -else - { $as_echo "$as_me:${as_lineno-$LINENO}: result: no" >&5 -$as_echo "no" >&6; } -fi - - - test -n "$ac_ct_F77" && break -done - - if test "x$ac_ct_F77" = x; then - F77="" - else - case $cross_compiling:$ac_tool_warned in -yes:) -{ $as_echo "$as_me:${as_lineno-$LINENO}: WARNING: using cross tools not prefixed with host triplet" >&5 -$as_echo "$as_me: WARNING: using cross tools not prefixed with host triplet" >&2;} -ac_tool_warned=yes ;; -esac - F77=$ac_ct_F77 - fi -fi - - -# Provide some information about the compiler. -$as_echo "$as_me:${as_lineno-$LINENO}: checking for Fortran 77 compiler version" >&5 -set X $ac_compile -ac_compiler=$2 -for ac_option in --version -v -V -qversion; do - { { ac_try="$ac_compiler $ac_option >&5" -case "(($ac_try" in - *\"* | *\`* | *\\*) ac_try_echo=\$ac_try;; - *) ac_try_echo=$ac_try;; -esac -eval ac_try_echo="\"\$as_me:${as_lineno-$LINENO}: $ac_try_echo\"" -$as_echo "$ac_try_echo"; } >&5 - (eval "$ac_compiler $ac_option >&5") 2>conftest.err - ac_status=$? - if test -s conftest.err; then - sed '10a\ -... rest of stderr output deleted ... - 10q' conftest.err >conftest.er1 - cat conftest.er1 >&5 - fi - rm -f conftest.er1 conftest.err - $as_echo "$as_me:${as_lineno-$LINENO}: \$? = $ac_status" >&5 - test $ac_status = 0; } -done -rm -f a.out - -# If we don't use `.F' as extension, the preprocessor is not run on the -# input file. (Note that this only needs to work for GNU compilers.) -ac_save_ext=$ac_ext -ac_ext=F -{ $as_echo "$as_me:${as_lineno-$LINENO}: checking whether we are using the GNU Fortran 77 compiler" >&5 -$as_echo_n "checking whether we are using the GNU Fortran 77 compiler... " >&6; } -if ${ac_cv_f77_compiler_gnu+:} false; then : - $as_echo_n "(cached) " >&6 -else - cat > conftest.$ac_ext <<_ACEOF - program main -#ifndef __GNUC__ - choke me -#endif - - end -_ACEOF -if ac_fn_f77_try_compile "$LINENO"; then : - ac_compiler_gnu=yes -else - ac_compiler_gnu=no -fi -rm -f core conftest.err conftest.$ac_objext conftest.$ac_ext -ac_cv_f77_compiler_gnu=$ac_compiler_gnu - -fi -{ $as_echo "$as_me:${as_lineno-$LINENO}: result: $ac_cv_f77_compiler_gnu" >&5 -$as_echo "$ac_cv_f77_compiler_gnu" >&6; } -ac_ext=$ac_save_ext -ac_test_FFLAGS=${FFLAGS+set} -ac_save_FFLAGS=$FFLAGS -FFLAGS= -{ $as_echo "$as_me:${as_lineno-$LINENO}: checking whether $F77 accepts -g" >&5 -$as_echo_n "checking whether $F77 accepts -g... " >&6; } -if ${ac_cv_prog_f77_g+:} false; then : - $as_echo_n "(cached) " >&6 -else - FFLAGS=-g -cat > conftest.$ac_ext <<_ACEOF - program main - - end -_ACEOF -if ac_fn_f77_try_compile "$LINENO"; then : - ac_cv_prog_f77_g=yes -else - ac_cv_prog_f77_g=no -fi -rm -f core conftest.err conftest.$ac_objext conftest.$ac_ext - -fi -{ $as_echo "$as_me:${as_lineno-$LINENO}: result: $ac_cv_prog_f77_g" >&5 -$as_echo "$ac_cv_prog_f77_g" >&6; } -if test "$ac_test_FFLAGS" = set; then - FFLAGS=$ac_save_FFLAGS -elif test $ac_cv_prog_f77_g = yes; then - if test "x$ac_cv_f77_compiler_gnu" = xyes; then - FFLAGS="-g -O2" - else - FFLAGS="-g" - fi -else - if test "x$ac_cv_f77_compiler_gnu" = xyes; then - FFLAGS="-O2" - else - FFLAGS= - fi -fi - -if test $ac_compiler_gnu = yes; then - G77=yes -else - G77= -fi -ac_ext=c -ac_cpp='$CPP $CPPFLAGS' -ac_compile='$CC -c $CFLAGS $CPPFLAGS conftest.$ac_ext >&5' -ac_link='$CC -o conftest$ac_exeext $CFLAGS $CPPFLAGS $LDFLAGS conftest.$ac_ext $LIBS >&5' -ac_compiler_gnu=$ac_cv_c_compiler_gnu - - MINPACKDIR=minpack - - LDMINPACK=-L../minpack - - -fi - - -@%:@ Check whether --enable-vo was given. -if test "${enable_vo+set}" = set; then : - enableval=$enable_vo; disable_vo=yes -else - disable_vo=no -fi - -@%:@ Check whether --enable-cli was given. -if test "${enable_cli+set}" = set; then : - enableval=$enable_cli; disable_cli=yes -else - disable_cli=no -fi - -@%:@ Check whether --enable-gui was given. -if test "${enable_gui+set}" = set; then : - enableval=$enable_gui; disable_gui=yes -else - disable_gui=no -fi - - -if test "x$disable_cli" = "xno" -o "x$disable_vo" = "xno" -o "x$disable_gui" = "xno"; then - - - -@%:@ Check whether --with-wxdir was given. -if test "${with_wxdir+set}" = set; then : - withval=$with_wxdir; wx_config_name="$withval/wx-config" - wx_config_args="--inplace" -fi - - -@%:@ Check whether --with-wx-config was given. -if test "${with_wx_config+set}" = set; then : - withval=$with_wx_config; wx_config_name="$withval" -fi - - -@%:@ Check whether --with-wx-prefix was given. -if test "${with_wx_prefix+set}" = set; then : - withval=$with_wx_prefix; wx_config_prefix="$withval" -else - wx_config_prefix="" -fi - - -@%:@ Check whether --with-wx-exec-prefix was given. -if test "${with_wx_exec_prefix+set}" = set; then : - withval=$with_wx_exec_prefix; wx_config_exec_prefix="$withval" -else - wx_config_exec_prefix="" -fi - - - - - if test x${WX_CONFIG_NAME+set} != xset ; then - WX_CONFIG_NAME=wx-config - fi - - if test "x$wx_config_name" != x ; then - WX_CONFIG_NAME="$wx_config_name" - fi - - if test x$wx_config_exec_prefix != x ; then - wx_config_args="$wx_config_args --exec-prefix=$wx_config_exec_prefix" - WX_LOOKUP_PATH="$wx_config_exec_prefix/bin" - fi - if test x$wx_config_prefix != x ; then - wx_config_args="$wx_config_args --prefix=$wx_config_prefix" - WX_LOOKUP_PATH="$WX_LOOKUP_PATH:$wx_config_prefix/bin" - fi - if test "$cross_compiling" = "yes"; then - wx_config_args="$wx_config_args --host=$host_alias" - fi - - if test -x "$WX_CONFIG_NAME" ; then - { $as_echo "$as_me:${as_lineno-$LINENO}: checking for wx-config" >&5 -$as_echo_n "checking for wx-config... " >&6; } - WX_CONFIG_PATH="$WX_CONFIG_NAME" - { $as_echo "$as_me:${as_lineno-$LINENO}: result: $WX_CONFIG_PATH" >&5 -$as_echo "$WX_CONFIG_PATH" >&6; } - else - # Extract the first word of "$WX_CONFIG_NAME", so it can be a program name with args. -set dummy $WX_CONFIG_NAME; ac_word=$2 -{ $as_echo "$as_me:${as_lineno-$LINENO}: checking for $ac_word" >&5 -$as_echo_n "checking for $ac_word... " >&6; } -if ${ac_cv_path_WX_CONFIG_PATH+:} false; then : - $as_echo_n "(cached) " >&6 -else - case $WX_CONFIG_PATH in - [\\/]* | ?:[\\/]*) - ac_cv_path_WX_CONFIG_PATH="$WX_CONFIG_PATH" # Let the user override the test with a path. - ;; - *) - as_save_IFS=$IFS; IFS=$PATH_SEPARATOR -as_dummy=""$WX_LOOKUP_PATH:$PATH"" -for as_dir in $as_dummy -do - IFS=$as_save_IFS - test -z "$as_dir" && as_dir=. - for ac_exec_ext in '' $ac_executable_extensions; do - if as_fn_executable_p "$as_dir/$ac_word$ac_exec_ext"; then - ac_cv_path_WX_CONFIG_PATH="$as_dir/$ac_word$ac_exec_ext" - $as_echo "$as_me:${as_lineno-$LINENO}: found $as_dir/$ac_word$ac_exec_ext" >&5 - break 2 - fi -done - done -IFS=$as_save_IFS - - test -z "$ac_cv_path_WX_CONFIG_PATH" && ac_cv_path_WX_CONFIG_PATH="no" - ;; -esac -fi -WX_CONFIG_PATH=$ac_cv_path_WX_CONFIG_PATH -if test -n "$WX_CONFIG_PATH"; then - { $as_echo "$as_me:${as_lineno-$LINENO}: result: $WX_CONFIG_PATH" >&5 -$as_echo "$WX_CONFIG_PATH" >&6; } -else - { $as_echo "$as_me:${as_lineno-$LINENO}: result: no" >&5 -$as_echo "no" >&6; } -fi - - - fi - - if test "$WX_CONFIG_PATH" != "no" ; then - WX_VERSION="" - - min_wx_version=3.0.0 - if test -z "" ; then - { $as_echo "$as_me:${as_lineno-$LINENO}: checking for wxWidgets version >= $min_wx_version" >&5 -$as_echo_n "checking for wxWidgets version >= $min_wx_version... " >&6; } - else - { $as_echo "$as_me:${as_lineno-$LINENO}: checking for wxWidgets version >= $min_wx_version ()" >&5 -$as_echo_n "checking for wxWidgets version >= $min_wx_version ()... " >&6; } - fi - - WX_CONFIG_WITH_ARGS="$WX_CONFIG_PATH $wx_config_args " - - WX_VERSION=`$WX_CONFIG_WITH_ARGS --version 2>/dev/null` - wx_config_major_version=`echo $WX_VERSION | \ - sed 's/\([0-9]*\).\([0-9]*\).\([0-9]*\)/\1/'` - wx_config_minor_version=`echo $WX_VERSION | \ - sed 's/\([0-9]*\).\([0-9]*\).\([0-9]*\)/\2/'` - wx_config_micro_version=`echo $WX_VERSION | \ - sed 's/\([0-9]*\).\([0-9]*\).\([0-9]*\)/\3/'` - - wx_requested_major_version=`echo $min_wx_version | \ - sed 's/\([0-9]*\).\([0-9]*\).\([0-9]*\)/\1/'` - wx_requested_minor_version=`echo $min_wx_version | \ - sed 's/\([0-9]*\).\([0-9]*\).\([0-9]*\)/\2/'` - wx_requested_micro_version=`echo $min_wx_version | \ - sed 's/\([0-9]*\).\([0-9]*\).\([0-9]*\)/\3/'` - - - wx_ver_ok="" - if test "x$WX_VERSION" != x ; then - if test $wx_config_major_version -gt $wx_requested_major_version; then - wx_ver_ok=yes - else - if test $wx_config_major_version -eq $wx_requested_major_version; then - if test $wx_config_minor_version -gt $wx_requested_minor_version; then - wx_ver_ok=yes - else - if test $wx_config_minor_version -eq $wx_requested_minor_version; then - if test $wx_config_micro_version -ge $wx_requested_micro_version; then - wx_ver_ok=yes - fi - fi - fi - fi - fi - fi - - - if test -n "$wx_ver_ok"; then - { $as_echo "$as_me:${as_lineno-$LINENO}: result: yes (version $WX_VERSION)" >&5 -$as_echo "yes (version $WX_VERSION)" >&6; } - WX_LIBS=`$WX_CONFIG_WITH_ARGS --libs ` - - { $as_echo "$as_me:${as_lineno-$LINENO}: checking for wxWidgets static library" >&5 -$as_echo_n "checking for wxWidgets static library... " >&6; } - WX_LIBS_STATIC=`$WX_CONFIG_WITH_ARGS --static --libs 2>/dev/null` - if test "x$WX_LIBS_STATIC" = "x"; then - { $as_echo "$as_me:${as_lineno-$LINENO}: result: no" >&5 -$as_echo "no" >&6; } - else - { $as_echo "$as_me:${as_lineno-$LINENO}: result: yes" >&5 -$as_echo "yes" >&6; } - fi - - wx_has_cppflags="" - if test $wx_config_major_version -gt 2; then - wx_has_cppflags=yes - else - if test $wx_config_major_version -eq 2; then - if test $wx_config_minor_version -gt 2; then - wx_has_cppflags=yes - else - if test $wx_config_minor_version -eq 2; then - if test $wx_config_micro_version -ge 6; then - wx_has_cppflags=yes - fi - fi - fi - fi - fi - - wx_has_rescomp="" - if test $wx_config_major_version -gt 2; then - wx_has_rescomp=yes - else - if test $wx_config_major_version -eq 2; then - if test $wx_config_minor_version -ge 7; then - wx_has_rescomp=yes - fi - fi - fi - if test "x$wx_has_rescomp" = x ; then - WX_RESCOMP= - else - WX_RESCOMP=`$WX_CONFIG_WITH_ARGS --rescomp` - fi - - if test "x$wx_has_cppflags" = x ; then - WX_CFLAGS=`$WX_CONFIG_WITH_ARGS --cflags ` - WX_CPPFLAGS=$WX_CFLAGS - WX_CXXFLAGS=$WX_CFLAGS - - WX_CFLAGS_ONLY=$WX_CFLAGS - WX_CXXFLAGS_ONLY=$WX_CFLAGS - else - WX_CPPFLAGS=`$WX_CONFIG_WITH_ARGS --cppflags ` - WX_CXXFLAGS=`$WX_CONFIG_WITH_ARGS --cxxflags ` - WX_CFLAGS=`$WX_CONFIG_WITH_ARGS --cflags ` - - WX_CFLAGS_ONLY=`echo $WX_CFLAGS | sed "s@^$WX_CPPFLAGS *@@"` - WX_CXXFLAGS_ONLY=`echo $WX_CXXFLAGS | sed "s@^$WX_CFLAGS *@@"` - fi - - wxWin=1 - - else - - if test "x$WX_VERSION" = x; then - { $as_echo "$as_me:${as_lineno-$LINENO}: result: no" >&5 -$as_echo "no" >&6; } - else - { $as_echo "$as_me:${as_lineno-$LINENO}: result: no (version $WX_VERSION is not new enough)" >&5 -$as_echo "no (version $WX_VERSION is not new enough)" >&6; } - fi - - WX_CFLAGS="" - WX_CPPFLAGS="" - WX_CXXFLAGS="" - WX_LIBS="" - WX_LIBS_STATIC="" - WX_RESCOMP="" - - if test ! -z ""; then - - wx_error_message=" - The configuration you asked for $PACKAGE_NAME requires a wxWidgets - build with the following settings: - - but such build is not available. - - To see the wxWidgets builds available on this system, please use - 'wx-config --list' command. To use the default build, returned by - 'wx-config --selected-config', use the options with their 'auto' - default values." - - fi - - wx_error_message=" - The requested wxWidgets build couldn't be found. - $wx_error_message - - If you still get this error, then check that 'wx-config' is - in path, the directory where wxWidgets libraries are installed - (returned by 'wx-config --libs' command) is in LD_LIBRARY_PATH - or equivalent variable and wxWidgets version is 3.0.0 or above." - - as_fn_error $? "$wx_error_message" "$LINENO" 5 - - fi - else - - WX_CFLAGS="" - WX_CPPFLAGS="" - WX_CXXFLAGS="" - WX_LIBS="" - WX_LIBS_STATIC="" - WX_RESCOMP="" - - : - - fi - - - - - - - - - - - - WX_VERSION_MAJOR="$wx_config_major_version" - WX_VERSION_MINOR="$wx_config_minor_version" - WX_VERSION_MICRO="$wx_config_micro_version" - - - - - - - if test -z "$wxWin"; then - - { $as_echo "$as_me:${as_lineno-$LINENO}: WARNING: - - wxWidgets toolkit not found! - - Continuing without wxWidgets. - These parts may be unavailable (even required on command-line): - - * Both graphical and command-line interfaces - * Any functionality related to Virtual observatory - - Otherwise: - - Install wxWidgets on your system - - Please check: wx-config is available in PATH, a directory - where wxWidgets libraries are installed (returned by - 'wx-config --libs' command) is in LD_LIBRARY_PATH or - equivalent variable and appropriate wxWidgets version - is available. - " >&5 -$as_echo "$as_me: WARNING: - - wxWidgets toolkit not found! - - Continuing without wxWidgets. - These parts may be unavailable (even required on command-line): - - * Both graphical and command-line interfaces - * Any functionality related to Virtual observatory - - Otherwise: - - Install wxWidgets on your system - - Please check: wx-config is available in PATH, a directory - where wxWidgets libraries are installed (returned by - 'wx-config --libs' command) is in LD_LIBRARY_PATH or - equivalent variable and appropriate wxWidgets version - is available. - " >&2;} - - fi -fi - - -wxVO="no" -wxGUI="no" -wxCLI="no" - -if test "$wxWin" = 1; then - - if test "x$disable_gui" = "xno"; then - wxGUI="yes" - XMUNIPACKDIR=xmunipack - - MATPLOTDIR=wxMathPlot - - fi - - if test "x$disable_cli" = "xno"; then - wxCLI="yes" - MUNIPACKDIR=munipack - - WX_CXXFLAGS_CLI=`wx-config --cxxflags base` - - WX_LIBS_CLI=`wx-config --libs base` - - fi - - if test "x$disable_vo" = "xno"; then - wxVO="yes" - WX_LIBS_VO=`wx-config --libs base,net,xml` - - WX_CXXFLAGS_VO=`wx-config --cxxflags base,net,xml` - - VODIR=vo - - fi -fi - -@%:@ Check whether --enable-bundle was given. -if test "${enable_bundle+set}" = set; then : - enableval=$enable_bundle; enable_bundle=yes -else - enable_bundle=no -fi - - if test "x$enable_bundle" = "xyes"; then - BUNDLE_TRUE= - BUNDLE_FALSE='#' -else - BUNDLE_TRUE='#' - BUNDLE_FALSE= -fi - - - - -if test "x$enable_bundle" = "xyes"; then - BUNDLEDIR=${BUNDLEDIR:-/opt/munipack} - - LIBGFORTRAN=-static-libgfortran - - LIBGCC=-static-libgcc - - LIBSTDCPP=-static-libstdc++ - -fi - -CLEANFILES=*.$FC_MODEXT - - - -ac_config_headers="$ac_config_headers config.h" - - -ac_config_files="$ac_config_files minpack/Makefile lib/Makefile preprocess/Makefile kombine/Makefile photometry/Makefile artificial/Makefile fitsut/Makefile list/Makefile astrometry/Makefile coloring/Makefile vo/Makefile munipack/Makefile wxMathPlot/Makefile xmunipack/Makefile doc/Makefile Makefile" - - -cat >confcache <<\_ACEOF -# This file is a shell script that caches the results of configure -# tests run on this system so they can be shared between configure -# scripts and configure runs, see configure's option --config-cache. -# It is not useful on other systems. If it contains results you don't -# want to keep, you may remove or edit it. -# -# config.status only pays attention to the cache file if you give it -# the --recheck option to rerun configure. -# -# `ac_cv_env_foo' variables (set or unset) will be overridden when -# loading this file, other *unset* `ac_cv_foo' will be assigned the -# following values. - -_ACEOF - -# The following way of writing the cache mishandles newlines in values, -# but we know of no workaround that is simple, portable, and efficient. -# So, we kill variables containing newlines. -# Ultrix sh set writes to stderr and can't be redirected directly, -# and sets the high bit in the cache file unless we assign to the vars. -( - for ac_var in `(set) 2>&1 | sed -n 's/^\([a-zA-Z_][a-zA-Z0-9_]*\)=.*/\1/p'`; do - eval ac_val=\$$ac_var - case $ac_val in #( - *${as_nl}*) - case $ac_var in #( - *_cv_*) { $as_echo "$as_me:${as_lineno-$LINENO}: WARNING: cache variable $ac_var contains a newline" >&5 -$as_echo "$as_me: WARNING: cache variable $ac_var contains a newline" >&2;} ;; - esac - case $ac_var in #( - _ | IFS | as_nl) ;; #( - BASH_ARGV | BASH_SOURCE) eval $ac_var= ;; #( - *) { eval $ac_var=; unset $ac_var;} ;; - esac ;; - esac - done - - (set) 2>&1 | - case $as_nl`(ac_space=' '; set) 2>&1` in #( - *${as_nl}ac_space=\ *) - # `set' does not quote correctly, so add quotes: double-quote - # substitution turns \\\\ into \\, and sed turns \\ into \. - sed -n \ - "s/'/'\\\\''/g; - s/^\\([_$as_cr_alnum]*_cv_[_$as_cr_alnum]*\\)=\\(.*\\)/\\1='\\2'/p" - ;; #( - *) - # `set' quotes correctly as required by POSIX, so do not add quotes. - sed -n "/^[_$as_cr_alnum]*_cv_[_$as_cr_alnum]*=/p" - ;; - esac | - sort -) | - sed ' - /^ac_cv_env_/b end - t clear - :clear - s/^\([^=]*\)=\(.*[{}].*\)$/test "${\1+set}" = set || &/ - t end - s/^\([^=]*\)=\(.*\)$/\1=${\1=\2}/ - :end' >>confcache -if diff "$cache_file" confcache >/dev/null 2>&1; then :; else - if test -w "$cache_file"; then - if test "x$cache_file" != "x/dev/null"; then - { $as_echo "$as_me:${as_lineno-$LINENO}: updating cache $cache_file" >&5 -$as_echo "$as_me: updating cache $cache_file" >&6;} - if test ! -f "$cache_file" || test -h "$cache_file"; then - cat confcache >"$cache_file" - else - case $cache_file in #( - */* | ?:*) - mv -f confcache "$cache_file"$$ && - mv -f "$cache_file"$$ "$cache_file" ;; #( - *) - mv -f confcache "$cache_file" ;; - esac - fi - fi - else - { $as_echo "$as_me:${as_lineno-$LINENO}: not updating unwritable cache $cache_file" >&5 -$as_echo "$as_me: not updating unwritable cache $cache_file" >&6;} - fi -fi -rm -f confcache - -test "x$prefix" = xNONE && prefix=$ac_default_prefix -# Let make expand exec_prefix. -test "x$exec_prefix" = xNONE && exec_prefix='${prefix}' - -DEFS=-DHAVE_CONFIG_H - -ac_libobjs= -ac_ltlibobjs= -U= -for ac_i in : $LIB@&t@OBJS; do test "x$ac_i" = x: && continue - # 1. Remove the extension, and $U if already installed. - ac_script='s/\$U\././;s/\.o$//;s/\.obj$//' - ac_i=`$as_echo "$ac_i" | sed "$ac_script"` - # 2. Prepend LIBOBJDIR. When used with automake>=1.10 LIBOBJDIR - # will be set to the directory where LIBOBJS objects are built. - as_fn_append ac_libobjs " \${LIBOBJDIR}$ac_i\$U.$ac_objext" - as_fn_append ac_ltlibobjs " \${LIBOBJDIR}$ac_i"'$U.lo' -done -LIB@&t@OBJS=$ac_libobjs - -LTLIBOBJS=$ac_ltlibobjs - - -{ $as_echo "$as_me:${as_lineno-$LINENO}: checking that generated files are newer than configure" >&5 -$as_echo_n "checking that generated files are newer than configure... " >&6; } - if test -n "$am_sleep_pid"; then - # Hide warnings about reused PIDs. - wait $am_sleep_pid 2>/dev/null - fi - { $as_echo "$as_me:${as_lineno-$LINENO}: result: done" >&5 -$as_echo "done" >&6; } - if test -n "$EXEEXT"; then - am__EXEEXT_TRUE= - am__EXEEXT_FALSE='#' -else - am__EXEEXT_TRUE='#' - am__EXEEXT_FALSE= -fi - -if test -z "${AMDEP_TRUE}" && test -z "${AMDEP_FALSE}"; then - as_fn_error $? "conditional \"AMDEP\" was never defined. -Usually this means the macro was only invoked conditionally." "$LINENO" 5 -fi -if test -z "${am__fastdepCC_TRUE}" && test -z "${am__fastdepCC_FALSE}"; then - as_fn_error $? "conditional \"am__fastdepCC\" was never defined. -Usually this means the macro was only invoked conditionally." "$LINENO" 5 -fi -if test -z "${am__fastdepCXX_TRUE}" && test -z "${am__fastdepCXX_FALSE}"; then - as_fn_error $? "conditional \"am__fastdepCXX\" was never defined. -Usually this means the macro was only invoked conditionally." "$LINENO" 5 -fi -case $FC_MODINC in #( - *\ ) FC_MODINC=$FC_MODINC'${ac_empty}' ;; -esac -case $FC_MODOUT in #( - *\ ) FC_MODOUT=$FC_MODOUT'${ac_empty}' ;; -esac -if test -z "${BUNDLE_TRUE}" && test -z "${BUNDLE_FALSE}"; then - as_fn_error $? "conditional \"BUNDLE\" was never defined. -Usually this means the macro was only invoked conditionally." "$LINENO" 5 -fi - -: "${CONFIG_STATUS=./config.status}" -ac_write_fail=0 -ac_clean_files_save=$ac_clean_files -ac_clean_files="$ac_clean_files $CONFIG_STATUS" -{ $as_echo "$as_me:${as_lineno-$LINENO}: creating $CONFIG_STATUS" >&5 -$as_echo "$as_me: creating $CONFIG_STATUS" >&6;} -as_write_fail=0 -cat >$CONFIG_STATUS <<_ASEOF || as_write_fail=1 -#! $SHELL -# Generated by $as_me. -# Run this file to recreate the current configuration. -# Compiler output produced by configure, useful for debugging -# configure, is in config.log if it exists. - -debug=false -ac_cs_recheck=false -ac_cs_silent=false - -SHELL=\${CONFIG_SHELL-$SHELL} -export SHELL -_ASEOF -cat >>$CONFIG_STATUS <<\_ASEOF || as_write_fail=1 -## -------------------- ## -## M4sh Initialization. ## -## -------------------- ## - -# Be more Bourne compatible -DUALCASE=1; export DUALCASE # for MKS sh -if test -n "${ZSH_VERSION+set}" && (emulate sh) >/dev/null 2>&1; then : - emulate sh - NULLCMD=: - # Pre-4.2 versions of Zsh do word splitting on ${1+"$@"}, which - # is contrary to our usage. Disable this feature. - alias -g '${1+"$@"}'='"$@"' - setopt NO_GLOB_SUBST -else - case `(set -o) 2>/dev/null` in @%:@( - *posix*) : - set -o posix ;; @%:@( - *) : - ;; -esac -fi - - -as_nl=' -' -export as_nl -# Printing a long string crashes Solaris 7 /usr/bin/printf. -as_echo='\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\' -as_echo=$as_echo$as_echo$as_echo$as_echo$as_echo -as_echo=$as_echo$as_echo$as_echo$as_echo$as_echo$as_echo -# Prefer a ksh shell builtin over an external printf program on Solaris, -# but without wasting forks for bash or zsh. -if test -z "$BASH_VERSION$ZSH_VERSION" \ - && (test "X`print -r -- $as_echo`" = "X$as_echo") 2>/dev/null; then - as_echo='print -r --' - as_echo_n='print -rn --' -elif (test "X`printf %s $as_echo`" = "X$as_echo") 2>/dev/null; then - as_echo='printf %s\n' - as_echo_n='printf %s' -else - if test "X`(/usr/ucb/echo -n -n $as_echo) 2>/dev/null`" = "X-n $as_echo"; then - as_echo_body='eval /usr/ucb/echo -n "$1$as_nl"' - as_echo_n='/usr/ucb/echo -n' - else - as_echo_body='eval expr "X$1" : "X\\(.*\\)"' - as_echo_n_body='eval - arg=$1; - case $arg in @%:@( - *"$as_nl"*) - expr "X$arg" : "X\\(.*\\)$as_nl"; - arg=`expr "X$arg" : ".*$as_nl\\(.*\\)"`;; - esac; - expr "X$arg" : "X\\(.*\\)" | tr -d "$as_nl" - ' - export as_echo_n_body - as_echo_n='sh -c $as_echo_n_body as_echo' - fi - export as_echo_body - as_echo='sh -c $as_echo_body as_echo' -fi - -# The user is always right. -if test "${PATH_SEPARATOR+set}" != set; then - PATH_SEPARATOR=: - (PATH='/bin;/bin'; FPATH=$PATH; sh -c :) >/dev/null 2>&1 && { - (PATH='/bin:/bin'; FPATH=$PATH; sh -c :) >/dev/null 2>&1 || - PATH_SEPARATOR=';' - } -fi - - -# IFS -# We need space, tab and new line, in precisely that order. Quoting is -# there to prevent editors from complaining about space-tab. -# (If _AS_PATH_WALK were called with IFS unset, it would disable word -# splitting by setting IFS to empty value.) -IFS=" "" $as_nl" - -# Find who we are. Look in the path if we contain no directory separator. -as_myself= -case $0 in @%:@(( - *[\\/]* ) as_myself=$0 ;; - *) as_save_IFS=$IFS; IFS=$PATH_SEPARATOR -for as_dir in $PATH -do - IFS=$as_save_IFS - test -z "$as_dir" && as_dir=. - test -r "$as_dir/$0" && as_myself=$as_dir/$0 && break - done -IFS=$as_save_IFS - - ;; -esac -# We did not find ourselves, most probably we were run as `sh COMMAND' -# in which case we are not to be found in the path. -if test "x$as_myself" = x; then - as_myself=$0 -fi -if test ! -f "$as_myself"; then - $as_echo "$as_myself: error: cannot find myself; rerun with an absolute file name" >&2 - exit 1 -fi - -# Unset variables that we do not need and which cause bugs (e.g. in -# pre-3.0 UWIN ksh). But do not cause bugs in bash 2.01; the "|| exit 1" -# suppresses any "Segmentation fault" message there. '((' could -# trigger a bug in pdksh 5.2.14. -for as_var in BASH_ENV ENV MAIL MAILPATH -do eval test x\${$as_var+set} = xset \ - && ( (unset $as_var) || exit 1) >/dev/null 2>&1 && unset $as_var || : -done -PS1='$ ' -PS2='> ' -PS4='+ ' - -# NLS nuisances. -LC_ALL=C -export LC_ALL -LANGUAGE=C -export LANGUAGE - -# CDPATH. -(unset CDPATH) >/dev/null 2>&1 && unset CDPATH - - -@%:@ as_fn_error STATUS ERROR [LINENO LOG_FD] -@%:@ ---------------------------------------- -@%:@ Output "`basename @S|@0`: error: ERROR" to stderr. If LINENO and LOG_FD are -@%:@ provided, also output the error to LOG_FD, referencing LINENO. Then exit the -@%:@ script with STATUS, using 1 if that was 0. -as_fn_error () -{ - as_status=$1; test $as_status -eq 0 && as_status=1 - if test "$4"; then - as_lineno=${as_lineno-"$3"} as_lineno_stack=as_lineno_stack=$as_lineno_stack - $as_echo "$as_me:${as_lineno-$LINENO}: error: $2" >&$4 - fi - $as_echo "$as_me: error: $2" >&2 - as_fn_exit $as_status -} @%:@ as_fn_error - - -@%:@ as_fn_set_status STATUS -@%:@ ----------------------- -@%:@ Set @S|@? to STATUS, without forking. -as_fn_set_status () -{ - return $1 -} @%:@ as_fn_set_status - -@%:@ as_fn_exit STATUS -@%:@ ----------------- -@%:@ Exit the shell with STATUS, even in a "trap 0" or "set -e" context. -as_fn_exit () -{ - set +e - as_fn_set_status $1 - exit $1 -} @%:@ as_fn_exit - -@%:@ as_fn_unset VAR -@%:@ --------------- -@%:@ Portably unset VAR. -as_fn_unset () -{ - { eval $1=; unset $1;} -} -as_unset=as_fn_unset -@%:@ as_fn_append VAR VALUE -@%:@ ---------------------- -@%:@ Append the text in VALUE to the end of the definition contained in VAR. Take -@%:@ advantage of any shell optimizations that allow amortized linear growth over -@%:@ repeated appends, instead of the typical quadratic growth present in naive -@%:@ implementations. -if (eval "as_var=1; as_var+=2; test x\$as_var = x12") 2>/dev/null; then : - eval 'as_fn_append () - { - eval $1+=\$2 - }' -else - as_fn_append () - { - eval $1=\$$1\$2 - } -fi # as_fn_append - -@%:@ as_fn_arith ARG... -@%:@ ------------------ -@%:@ Perform arithmetic evaluation on the ARGs, and store the result in the -@%:@ global @S|@as_val. Take advantage of shells that can avoid forks. The arguments -@%:@ must be portable across @S|@(()) and expr. -if (eval "test \$(( 1 + 1 )) = 2") 2>/dev/null; then : - eval 'as_fn_arith () - { - as_val=$(( $* )) - }' -else - as_fn_arith () - { - as_val=`expr "$@" || test $? -eq 1` - } -fi # as_fn_arith - - -if expr a : '\(a\)' >/dev/null 2>&1 && - test "X`expr 00001 : '.*\(...\)'`" = X001; then - as_expr=expr -else - as_expr=false -fi - -if (basename -- /) >/dev/null 2>&1 && test "X`basename -- / 2>&1`" = "X/"; then - as_basename=basename -else - as_basename=false -fi - -if (as_dir=`dirname -- /` && test "X$as_dir" = X/) >/dev/null 2>&1; then - as_dirname=dirname -else - as_dirname=false -fi - -as_me=`$as_basename -- "$0" || -$as_expr X/"$0" : '.*/\([^/][^/]*\)/*$' \| \ - X"$0" : 'X\(//\)$' \| \ - X"$0" : 'X\(/\)' \| . 2>/dev/null || -$as_echo X/"$0" | - sed '/^.*\/\([^/][^/]*\)\/*$/{ - s//\1/ - q - } - /^X\/\(\/\/\)$/{ - s//\1/ - q - } - /^X\/\(\/\).*/{ - s//\1/ - q - } - s/.*/./; q'` - -# Avoid depending upon Character Ranges. -as_cr_letters='abcdefghijklmnopqrstuvwxyz' -as_cr_LETTERS='ABCDEFGHIJKLMNOPQRSTUVWXYZ' -as_cr_Letters=$as_cr_letters$as_cr_LETTERS -as_cr_digits='0123456789' -as_cr_alnum=$as_cr_Letters$as_cr_digits - -ECHO_C= ECHO_N= ECHO_T= -case `echo -n x` in @%:@((((( --n*) - case `echo 'xy\c'` in - *c*) ECHO_T=' ';; # ECHO_T is single tab character. - xy) ECHO_C='\c';; - *) echo `echo ksh88 bug on AIX 6.1` > /dev/null - ECHO_T=' ';; - esac;; -*) - ECHO_N='-n';; -esac - -rm -f conf$$ conf$$.exe conf$$.file -if test -d conf$$.dir; then - rm -f conf$$.dir/conf$$.file -else - rm -f conf$$.dir - mkdir conf$$.dir 2>/dev/null -fi -if (echo >conf$$.file) 2>/dev/null; then - if ln -s conf$$.file conf$$ 2>/dev/null; then - as_ln_s='ln -s' - # ... but there are two gotchas: - # 1) On MSYS, both `ln -s file dir' and `ln file dir' fail. - # 2) DJGPP < 2.04 has no symlinks; `ln -s' creates a wrapper executable. - # In both cases, we have to default to `cp -pR'. - ln -s conf$$.file conf$$.dir 2>/dev/null && test ! -f conf$$.exe || - as_ln_s='cp -pR' - elif ln conf$$.file conf$$ 2>/dev/null; then - as_ln_s=ln - else - as_ln_s='cp -pR' - fi -else - as_ln_s='cp -pR' -fi -rm -f conf$$ conf$$.exe conf$$.dir/conf$$.file conf$$.file -rmdir conf$$.dir 2>/dev/null - - -@%:@ as_fn_mkdir_p -@%:@ ------------- -@%:@ Create "@S|@as_dir" as a directory, including parents if necessary. -as_fn_mkdir_p () -{ - - case $as_dir in #( - -*) as_dir=./$as_dir;; - esac - test -d "$as_dir" || eval $as_mkdir_p || { - as_dirs= - while :; do - case $as_dir in #( - *\'*) as_qdir=`$as_echo "$as_dir" | sed "s/'/'\\\\\\\\''/g"`;; #'( - *) as_qdir=$as_dir;; - esac - as_dirs="'$as_qdir' $as_dirs" - as_dir=`$as_dirname -- "$as_dir" || -$as_expr X"$as_dir" : 'X\(.*[^/]\)//*[^/][^/]*/*$' \| \ - X"$as_dir" : 'X\(//\)[^/]' \| \ - X"$as_dir" : 'X\(//\)$' \| \ - X"$as_dir" : 'X\(/\)' \| . 2>/dev/null || -$as_echo X"$as_dir" | - sed '/^X\(.*[^/]\)\/\/*[^/][^/]*\/*$/{ - s//\1/ - q - } - /^X\(\/\/\)[^/].*/{ - s//\1/ - q - } - /^X\(\/\/\)$/{ - s//\1/ - q - } - /^X\(\/\).*/{ - s//\1/ - q - } - s/.*/./; q'` - test -d "$as_dir" && break - done - test -z "$as_dirs" || eval "mkdir $as_dirs" - } || test -d "$as_dir" || as_fn_error $? "cannot create directory $as_dir" - - -} @%:@ as_fn_mkdir_p -if mkdir -p . 2>/dev/null; then - as_mkdir_p='mkdir -p "$as_dir"' -else - test -d ./-p && rmdir ./-p - as_mkdir_p=false -fi - - -@%:@ as_fn_executable_p FILE -@%:@ ----------------------- -@%:@ Test if FILE is an executable regular file. -as_fn_executable_p () -{ - test -f "$1" && test -x "$1" -} @%:@ as_fn_executable_p -as_test_x='test -x' -as_executable_p=as_fn_executable_p - -# Sed expression to map a string onto a valid CPP name. -as_tr_cpp="eval sed 'y%*$as_cr_letters%P$as_cr_LETTERS%;s%[^_$as_cr_alnum]%_%g'" - -# Sed expression to map a string onto a valid variable name. -as_tr_sh="eval sed 'y%*+%pp%;s%[^_$as_cr_alnum]%_%g'" - - -exec 6>&1 -## ----------------------------------- ## -## Main body of $CONFIG_STATUS script. ## -## ----------------------------------- ## -_ASEOF -test $as_write_fail = 0 && chmod +x $CONFIG_STATUS || ac_write_fail=1 - -cat >>$CONFIG_STATUS <<\_ACEOF || ac_write_fail=1 -# Save the log message, to keep $0 and so on meaningful, and to -# report actual input values of CONFIG_FILES etc. instead of their -# values after options handling. -ac_log=" -This file was extended by Munipack $as_me 0.5.9, which was -generated by GNU Autoconf 2.69. Invocation command line was - - CONFIG_FILES = $CONFIG_FILES - CONFIG_HEADERS = $CONFIG_HEADERS - CONFIG_LINKS = $CONFIG_LINKS - CONFIG_COMMANDS = $CONFIG_COMMANDS - $ $0 $@ - -on `(hostname || uname -n) 2>/dev/null | sed 1q` -" - -_ACEOF - -case $ac_config_files in *" -"*) set x $ac_config_files; shift; ac_config_files=$*;; -esac - -case $ac_config_headers in *" -"*) set x $ac_config_headers; shift; ac_config_headers=$*;; -esac - - -cat >>$CONFIG_STATUS <<_ACEOF || ac_write_fail=1 -# Files that config.status was made for. -config_files="$ac_config_files" -config_headers="$ac_config_headers" -config_commands="$ac_config_commands" - -_ACEOF - -cat >>$CONFIG_STATUS <<\_ACEOF || ac_write_fail=1 -ac_cs_usage="\ -\`$as_me' instantiates files and other configuration actions -from templates according to the current configuration. Unless the files -and actions are specified as TAGs, all are instantiated by default. - -Usage: $0 [OPTION]... [TAG]... - - -h, --help print this help, then exit - -V, --version print version number and configuration settings, then exit - --config print configuration, then exit - -q, --quiet, --silent - do not print progress messages - -d, --debug don't remove temporary files - --recheck update $as_me by reconfiguring in the same conditions - --file=FILE[:TEMPLATE] - instantiate the configuration file FILE - --header=FILE[:TEMPLATE] - instantiate the configuration header FILE - -Configuration files: -$config_files - -Configuration headers: -$config_headers - -Configuration commands: -$config_commands - -Report bugs to >. -Munipack home page: ." - -_ACEOF -cat >>$CONFIG_STATUS <<_ACEOF || ac_write_fail=1 -ac_cs_config="`$as_echo "$ac_configure_args" | sed 's/^ //; s/[\\""\`\$]/\\\\&/g'`" -ac_cs_version="\\ -Munipack config.status 0.5.9 -configured by $0, generated by GNU Autoconf 2.69, - with options \\"\$ac_cs_config\\" - -Copyright (C) 2012 Free Software Foundation, Inc. -This config.status script is free software; the Free Software Foundation -gives unlimited permission to copy, distribute and modify it." - -ac_pwd='$ac_pwd' -srcdir='$srcdir' -INSTALL='$INSTALL' -MKDIR_P='$MKDIR_P' -AWK='$AWK' -test -n "\$AWK" || AWK=awk -_ACEOF - -cat >>$CONFIG_STATUS <<\_ACEOF || ac_write_fail=1 -# The default lists apply if the user does not specify any file. -ac_need_defaults=: -while test $# != 0 -do - case $1 in - --*=?*) - ac_option=`expr "X$1" : 'X\([^=]*\)='` - ac_optarg=`expr "X$1" : 'X[^=]*=\(.*\)'` - ac_shift=: - ;; - --*=) - ac_option=`expr "X$1" : 'X\([^=]*\)='` - ac_optarg= - ac_shift=: - ;; - *) - ac_option=$1 - ac_optarg=$2 - ac_shift=shift - ;; - esac - - case $ac_option in - # Handling of the options. - -recheck | --recheck | --rechec | --reche | --rech | --rec | --re | --r) - ac_cs_recheck=: ;; - --version | --versio | --versi | --vers | --ver | --ve | --v | -V ) - $as_echo "$ac_cs_version"; exit ;; - --config | --confi | --conf | --con | --co | --c ) - $as_echo "$ac_cs_config"; exit ;; - --debug | --debu | --deb | --de | --d | -d ) - debug=: ;; - --file | --fil | --fi | --f ) - $ac_shift - case $ac_optarg in - *\'*) ac_optarg=`$as_echo "$ac_optarg" | sed "s/'/'\\\\\\\\''/g"` ;; - '') as_fn_error $? "missing file argument" ;; - esac - as_fn_append CONFIG_FILES " '$ac_optarg'" - ac_need_defaults=false;; - --header | --heade | --head | --hea ) - $ac_shift - case $ac_optarg in - *\'*) ac_optarg=`$as_echo "$ac_optarg" | sed "s/'/'\\\\\\\\''/g"` ;; - esac - as_fn_append CONFIG_HEADERS " '$ac_optarg'" - ac_need_defaults=false;; - --he | --h) - # Conflict between --help and --header - as_fn_error $? "ambiguous option: \`$1' -Try \`$0 --help' for more information.";; - --help | --hel | -h ) - $as_echo "$ac_cs_usage"; exit ;; - -q | -quiet | --quiet | --quie | --qui | --qu | --q \ - | -silent | --silent | --silen | --sile | --sil | --si | --s) - ac_cs_silent=: ;; - - # This is an error. - -*) as_fn_error $? "unrecognized option: \`$1' -Try \`$0 --help' for more information." ;; - - *) as_fn_append ac_config_targets " $1" - ac_need_defaults=false ;; - - esac - shift -done - -ac_configure_extra_args= - -if $ac_cs_silent; then - exec 6>/dev/null - ac_configure_extra_args="$ac_configure_extra_args --silent" -fi - -_ACEOF -cat >>$CONFIG_STATUS <<_ACEOF || ac_write_fail=1 -if \$ac_cs_recheck; then - set X $SHELL '$0' $ac_configure_args \$ac_configure_extra_args --no-create --no-recursion - shift - \$as_echo "running CONFIG_SHELL=$SHELL \$*" >&6 - CONFIG_SHELL='$SHELL' - export CONFIG_SHELL - exec "\$@" -fi - -_ACEOF -cat >>$CONFIG_STATUS <<\_ACEOF || ac_write_fail=1 -exec 5>>config.log -{ - echo - sed 'h;s/./-/g;s/^.../@%:@@%:@ /;s/...$/ @%:@@%:@/;p;x;p;x' <<_ASBOX -@%:@@%:@ Running $as_me. @%:@@%:@ -_ASBOX - $as_echo "$ac_log" -} >&5 - -_ACEOF -cat >>$CONFIG_STATUS <<_ACEOF || ac_write_fail=1 -# -# INIT-COMMANDS -# -AMDEP_TRUE="$AMDEP_TRUE" ac_aux_dir="$ac_aux_dir" - -_ACEOF - -cat >>$CONFIG_STATUS <<\_ACEOF || ac_write_fail=1 - -# Handling of arguments. -for ac_config_target in $ac_config_targets -do - case $ac_config_target in - "depfiles") CONFIG_COMMANDS="$CONFIG_COMMANDS depfiles" ;; - "config.h") CONFIG_HEADERS="$CONFIG_HEADERS config.h" ;; - "minpack/Makefile") CONFIG_FILES="$CONFIG_FILES minpack/Makefile" ;; - "lib/Makefile") CONFIG_FILES="$CONFIG_FILES lib/Makefile" ;; - "preprocess/Makefile") CONFIG_FILES="$CONFIG_FILES preprocess/Makefile" ;; - "kombine/Makefile") CONFIG_FILES="$CONFIG_FILES kombine/Makefile" ;; - "photometry/Makefile") CONFIG_FILES="$CONFIG_FILES photometry/Makefile" ;; - "artificial/Makefile") CONFIG_FILES="$CONFIG_FILES artificial/Makefile" ;; - "fitsut/Makefile") CONFIG_FILES="$CONFIG_FILES fitsut/Makefile" ;; - "list/Makefile") CONFIG_FILES="$CONFIG_FILES list/Makefile" ;; - "astrometry/Makefile") CONFIG_FILES="$CONFIG_FILES astrometry/Makefile" ;; - "coloring/Makefile") CONFIG_FILES="$CONFIG_FILES coloring/Makefile" ;; - "vo/Makefile") CONFIG_FILES="$CONFIG_FILES vo/Makefile" ;; - "munipack/Makefile") CONFIG_FILES="$CONFIG_FILES munipack/Makefile" ;; - "wxMathPlot/Makefile") CONFIG_FILES="$CONFIG_FILES wxMathPlot/Makefile" ;; - "xmunipack/Makefile") CONFIG_FILES="$CONFIG_FILES xmunipack/Makefile" ;; - "doc/Makefile") CONFIG_FILES="$CONFIG_FILES doc/Makefile" ;; - "Makefile") CONFIG_FILES="$CONFIG_FILES Makefile" ;; - - *) as_fn_error $? "invalid argument: \`$ac_config_target'" "$LINENO" 5;; - esac -done - - -# If the user did not use the arguments to specify the items to instantiate, -# then the envvar interface is used. Set only those that are not. -# We use the long form for the default assignment because of an extremely -# bizarre bug on SunOS 4.1.3. -if $ac_need_defaults; then - test "${CONFIG_FILES+set}" = set || CONFIG_FILES=$config_files - test "${CONFIG_HEADERS+set}" = set || CONFIG_HEADERS=$config_headers - test "${CONFIG_COMMANDS+set}" = set || CONFIG_COMMANDS=$config_commands -fi - -# Have a temporary directory for convenience. Make it in the build tree -# simply because there is no reason against having it here, and in addition, -# creating and moving files from /tmp can sometimes cause problems. -# Hook for its removal unless debugging. -# Note that there is a small window in which the directory will not be cleaned: -# after its creation but before its name has been assigned to `$tmp'. -$debug || -{ - tmp= ac_tmp= - trap 'exit_status=$? - : "${ac_tmp:=$tmp}" - { test ! -d "$ac_tmp" || rm -fr "$ac_tmp"; } && exit $exit_status -' 0 - trap 'as_fn_exit 1' 1 2 13 15 -} -# Create a (secure) tmp directory for tmp files. - -{ - tmp=`(umask 077 && mktemp -d "./confXXXXXX") 2>/dev/null` && - test -d "$tmp" -} || -{ - tmp=./conf$$-$RANDOM - (umask 077 && mkdir "$tmp") -} || as_fn_error $? "cannot create a temporary directory in ." "$LINENO" 5 -ac_tmp=$tmp - -# Set up the scripts for CONFIG_FILES section. -# No need to generate them if there are no CONFIG_FILES. -# This happens for instance with `./config.status config.h'. -if test -n "$CONFIG_FILES"; then - - -ac_cr=`echo X | tr X '\015'` -# On cygwin, bash can eat \r inside `` if the user requested igncr. -# But we know of no other shell where ac_cr would be empty at this -# point, so we can use a bashism as a fallback. -if test "x$ac_cr" = x; then - eval ac_cr=\$\'\\r\' -fi -ac_cs_awk_cr=`$AWK 'BEGIN { print "a\rb" }' /dev/null` -if test "$ac_cs_awk_cr" = "a${ac_cr}b"; then - ac_cs_awk_cr='\\r' -else - ac_cs_awk_cr=$ac_cr -fi - -echo 'BEGIN {' >"$ac_tmp/subs1.awk" && -_ACEOF - - -{ - echo "cat >conf$$subs.awk <<_ACEOF" && - echo "$ac_subst_vars" | sed 's/.*/&!$&$ac_delim/' && - echo "_ACEOF" -} >conf$$subs.sh || - as_fn_error $? "could not make $CONFIG_STATUS" "$LINENO" 5 -ac_delim_num=`echo "$ac_subst_vars" | grep -c '^'` -ac_delim='%!_!# ' -for ac_last_try in false false false false false :; do - . ./conf$$subs.sh || - as_fn_error $? "could not make $CONFIG_STATUS" "$LINENO" 5 - - ac_delim_n=`sed -n "s/.*$ac_delim\$/X/p" conf$$subs.awk | grep -c X` - if test $ac_delim_n = $ac_delim_num; then - break - elif $ac_last_try; then - as_fn_error $? "could not make $CONFIG_STATUS" "$LINENO" 5 - else - ac_delim="$ac_delim!$ac_delim _$ac_delim!! " - fi -done -rm -f conf$$subs.sh - -cat >>$CONFIG_STATUS <<_ACEOF || ac_write_fail=1 -cat >>"\$ac_tmp/subs1.awk" <<\\_ACAWK && -_ACEOF -sed -n ' -h -s/^/S["/; s/!.*/"]=/ -p -g -s/^[^!]*!// -:repl -t repl -s/'"$ac_delim"'$// -t delim -:nl -h -s/\(.\{148\}\)..*/\1/ -t more1 -s/["\\]/\\&/g; s/^/"/; s/$/\\n"\\/ -p -n -b repl -:more1 -s/["\\]/\\&/g; s/^/"/; s/$/"\\/ -p -g -s/.\{148\}// -t nl -:delim -h -s/\(.\{148\}\)..*/\1/ -t more2 -s/["\\]/\\&/g; s/^/"/; s/$/"/ -p -b -:more2 -s/["\\]/\\&/g; s/^/"/; s/$/"\\/ -p -g -s/.\{148\}// -t delim -' >$CONFIG_STATUS || ac_write_fail=1 -rm -f conf$$subs.awk -cat >>$CONFIG_STATUS <<_ACEOF || ac_write_fail=1 -_ACAWK -cat >>"\$ac_tmp/subs1.awk" <<_ACAWK && - for (key in S) S_is_set[key] = 1 - FS = "" - -} -{ - line = $ 0 - nfields = split(line, field, "@") - substed = 0 - len = length(field[1]) - for (i = 2; i < nfields; i++) { - key = field[i] - keylen = length(key) - if (S_is_set[key]) { - value = S[key] - line = substr(line, 1, len) "" value "" substr(line, len + keylen + 3) - len += length(value) + length(field[++i]) - substed = 1 - } else - len += 1 + keylen - } - - print line -} - -_ACAWK -_ACEOF -cat >>$CONFIG_STATUS <<\_ACEOF || ac_write_fail=1 -if sed "s/$ac_cr//" < /dev/null > /dev/null 2>&1; then - sed "s/$ac_cr\$//; s/$ac_cr/$ac_cs_awk_cr/g" -else - cat -fi < "$ac_tmp/subs1.awk" > "$ac_tmp/subs.awk" \ - || as_fn_error $? "could not setup config files machinery" "$LINENO" 5 -_ACEOF - -# VPATH may cause trouble with some makes, so we remove sole $(srcdir), -# ${srcdir} and @srcdir@ entries from VPATH if srcdir is ".", strip leading and -# trailing colons and then remove the whole line if VPATH becomes empty -# (actually we leave an empty line to preserve line numbers). -if test "x$srcdir" = x.; then - ac_vpsub='/^[ ]*VPATH[ ]*=[ ]*/{ -h -s/// -s/^/:/ -s/[ ]*$/:/ -s/:\$(srcdir):/:/g -s/:\${srcdir}:/:/g -s/:@srcdir@:/:/g -s/^:*// -s/:*$// -x -s/\(=[ ]*\).*/\1/ -G -s/\n// -s/^[^=]*=[ ]*$// -}' -fi - -cat >>$CONFIG_STATUS <<\_ACEOF || ac_write_fail=1 -fi # test -n "$CONFIG_FILES" - -# Set up the scripts for CONFIG_HEADERS section. -# No need to generate them if there are no CONFIG_HEADERS. -# This happens for instance with `./config.status Makefile'. -if test -n "$CONFIG_HEADERS"; then -cat >"$ac_tmp/defines.awk" <<\_ACAWK || -BEGIN { -_ACEOF - -# Transform confdefs.h into an awk script `defines.awk', embedded as -# here-document in config.status, that substitutes the proper values into -# config.h.in to produce config.h. - -# Create a delimiter string that does not exist in confdefs.h, to ease -# handling of long lines. -ac_delim='%!_!# ' -for ac_last_try in false false :; do - ac_tt=`sed -n "/$ac_delim/p" confdefs.h` - if test -z "$ac_tt"; then - break - elif $ac_last_try; then - as_fn_error $? "could not make $CONFIG_HEADERS" "$LINENO" 5 - else - ac_delim="$ac_delim!$ac_delim _$ac_delim!! " - fi -done - -# For the awk script, D is an array of macro values keyed by name, -# likewise P contains macro parameters if any. Preserve backslash -# newline sequences. - -ac_word_re=[_$as_cr_Letters][_$as_cr_alnum]* -sed -n ' -s/.\{148\}/&'"$ac_delim"'/g -t rset -:rset -s/^[ ]*#[ ]*define[ ][ ]*/ / -t def -d -:def -s/\\$// -t bsnl -s/["\\]/\\&/g -s/^ \('"$ac_word_re"'\)\(([^()]*)\)[ ]*\(.*\)/P["\1"]="\2"\ -D["\1"]=" \3"/p -s/^ \('"$ac_word_re"'\)[ ]*\(.*\)/D["\1"]=" \2"/p -d -:bsnl -s/["\\]/\\&/g -s/^ \('"$ac_word_re"'\)\(([^()]*)\)[ ]*\(.*\)/P["\1"]="\2"\ -D["\1"]=" \3\\\\\\n"\\/p -t cont -s/^ \('"$ac_word_re"'\)[ ]*\(.*\)/D["\1"]=" \2\\\\\\n"\\/p -t cont -d -:cont -n -s/.\{148\}/&'"$ac_delim"'/g -t clear -:clear -s/\\$// -t bsnlc -s/["\\]/\\&/g; s/^/"/; s/$/"/p -d -:bsnlc -s/["\\]/\\&/g; s/^/"/; s/$/\\\\\\n"\\/p -b cont -' >$CONFIG_STATUS || ac_write_fail=1 - -cat >>$CONFIG_STATUS <<_ACEOF || ac_write_fail=1 - for (key in D) D_is_set[key] = 1 - FS = "" -} -/^[\t ]*#[\t ]*(define|undef)[\t ]+$ac_word_re([\t (]|\$)/ { - line = \$ 0 - split(line, arg, " ") - if (arg[1] == "#") { - defundef = arg[2] - mac1 = arg[3] - } else { - defundef = substr(arg[1], 2) - mac1 = arg[2] - } - split(mac1, mac2, "(") #) - macro = mac2[1] - prefix = substr(line, 1, index(line, defundef) - 1) - if (D_is_set[macro]) { - # Preserve the white space surrounding the "#". - print prefix "define", macro P[macro] D[macro] - next - } else { - # Replace #undef with comments. This is necessary, for example, - # in the case of _POSIX_SOURCE, which is predefined and required - # on some systems where configure will not decide to define it. - if (defundef == "undef") { - print "/*", prefix defundef, macro, "*/" - next - } - } -} -{ print } -_ACAWK -_ACEOF -cat >>$CONFIG_STATUS <<\_ACEOF || ac_write_fail=1 - as_fn_error $? "could not setup config headers machinery" "$LINENO" 5 -fi # test -n "$CONFIG_HEADERS" - - -eval set X " :F $CONFIG_FILES :H $CONFIG_HEADERS :C $CONFIG_COMMANDS" -shift -for ac_tag -do - case $ac_tag in - :[FHLC]) ac_mode=$ac_tag; continue;; - esac - case $ac_mode$ac_tag in - :[FHL]*:*);; - :L* | :C*:*) as_fn_error $? "invalid tag \`$ac_tag'" "$LINENO" 5;; - :[FH]-) ac_tag=-:-;; - :[FH]*) ac_tag=$ac_tag:$ac_tag.in;; - esac - ac_save_IFS=$IFS - IFS=: - set x $ac_tag - IFS=$ac_save_IFS - shift - ac_file=$1 - shift - - case $ac_mode in - :L) ac_source=$1;; - :[FH]) - ac_file_inputs= - for ac_f - do - case $ac_f in - -) ac_f="$ac_tmp/stdin";; - *) # Look for the file first in the build tree, then in the source tree - # (if the path is not absolute). The absolute path cannot be DOS-style, - # because $ac_f cannot contain `:'. - test -f "$ac_f" || - case $ac_f in - [\\/$]*) false;; - *) test -f "$srcdir/$ac_f" && ac_f="$srcdir/$ac_f";; - esac || - as_fn_error 1 "cannot find input file: \`$ac_f'" "$LINENO" 5;; - esac - case $ac_f in *\'*) ac_f=`$as_echo "$ac_f" | sed "s/'/'\\\\\\\\''/g"`;; esac - as_fn_append ac_file_inputs " '$ac_f'" - done - - # Let's still pretend it is `configure' which instantiates (i.e., don't - # use $as_me), people would be surprised to read: - # /* config.h. Generated by config.status. */ - configure_input='Generated from '` - $as_echo "$*" | sed 's|^[^:]*/||;s|:[^:]*/|, |g' - `' by configure.' - if test x"$ac_file" != x-; then - configure_input="$ac_file. $configure_input" - { $as_echo "$as_me:${as_lineno-$LINENO}: creating $ac_file" >&5 -$as_echo "$as_me: creating $ac_file" >&6;} - fi - # Neutralize special characters interpreted by sed in replacement strings. - case $configure_input in #( - *\&* | *\|* | *\\* ) - ac_sed_conf_input=`$as_echo "$configure_input" | - sed 's/[\\\\&|]/\\\\&/g'`;; #( - *) ac_sed_conf_input=$configure_input;; - esac - - case $ac_tag in - *:-:* | *:-) cat >"$ac_tmp/stdin" \ - || as_fn_error $? "could not create $ac_file" "$LINENO" 5 ;; - esac - ;; - esac - - ac_dir=`$as_dirname -- "$ac_file" || -$as_expr X"$ac_file" : 'X\(.*[^/]\)//*[^/][^/]*/*$' \| \ - X"$ac_file" : 'X\(//\)[^/]' \| \ - X"$ac_file" : 'X\(//\)$' \| \ - X"$ac_file" : 'X\(/\)' \| . 2>/dev/null || -$as_echo X"$ac_file" | - sed '/^X\(.*[^/]\)\/\/*[^/][^/]*\/*$/{ - s//\1/ - q - } - /^X\(\/\/\)[^/].*/{ - s//\1/ - q - } - /^X\(\/\/\)$/{ - s//\1/ - q - } - /^X\(\/\).*/{ - s//\1/ - q - } - s/.*/./; q'` - as_dir="$ac_dir"; as_fn_mkdir_p - ac_builddir=. - -case "$ac_dir" in -.) ac_dir_suffix= ac_top_builddir_sub=. ac_top_build_prefix= ;; -*) - ac_dir_suffix=/`$as_echo "$ac_dir" | sed 's|^\.[\\/]||'` - # A ".." for each directory in $ac_dir_suffix. - ac_top_builddir_sub=`$as_echo "$ac_dir_suffix" | sed 's|/[^\\/]*|/..|g;s|/||'` - case $ac_top_builddir_sub in - "") ac_top_builddir_sub=. ac_top_build_prefix= ;; - *) ac_top_build_prefix=$ac_top_builddir_sub/ ;; - esac ;; -esac -ac_abs_top_builddir=$ac_pwd -ac_abs_builddir=$ac_pwd$ac_dir_suffix -# for backward compatibility: -ac_top_builddir=$ac_top_build_prefix - -case $srcdir in - .) # We are building in place. - ac_srcdir=. - ac_top_srcdir=$ac_top_builddir_sub - ac_abs_top_srcdir=$ac_pwd ;; - [\\/]* | ?:[\\/]* ) # Absolute name. - ac_srcdir=$srcdir$ac_dir_suffix; - ac_top_srcdir=$srcdir - ac_abs_top_srcdir=$srcdir ;; - *) # Relative name. - ac_srcdir=$ac_top_build_prefix$srcdir$ac_dir_suffix - ac_top_srcdir=$ac_top_build_prefix$srcdir - ac_abs_top_srcdir=$ac_pwd/$srcdir ;; -esac -ac_abs_srcdir=$ac_abs_top_srcdir$ac_dir_suffix - - - case $ac_mode in - :F) - # - # CONFIG_FILE - # - - case $INSTALL in - [\\/$]* | ?:[\\/]* ) ac_INSTALL=$INSTALL ;; - *) ac_INSTALL=$ac_top_build_prefix$INSTALL ;; - esac - ac_MKDIR_P=$MKDIR_P - case $MKDIR_P in - [\\/$]* | ?:[\\/]* ) ;; - */*) ac_MKDIR_P=$ac_top_build_prefix$MKDIR_P ;; - esac -_ACEOF - -cat >>$CONFIG_STATUS <<\_ACEOF || ac_write_fail=1 -# If the template does not know about datarootdir, expand it. -# FIXME: This hack should be removed a few years after 2.60. -ac_datarootdir_hack=; ac_datarootdir_seen= -ac_sed_dataroot=' -/datarootdir/ { - p - q -} -/@datadir@/p -/@docdir@/p -/@infodir@/p -/@localedir@/p -/@mandir@/p' -case `eval "sed -n \"\$ac_sed_dataroot\" $ac_file_inputs"` in -*datarootdir*) ac_datarootdir_seen=yes;; -*@datadir@*|*@docdir@*|*@infodir@*|*@localedir@*|*@mandir@*) - { $as_echo "$as_me:${as_lineno-$LINENO}: WARNING: $ac_file_inputs seems to ignore the --datarootdir setting" >&5 -$as_echo "$as_me: WARNING: $ac_file_inputs seems to ignore the --datarootdir setting" >&2;} -_ACEOF -cat >>$CONFIG_STATUS <<_ACEOF || ac_write_fail=1 - ac_datarootdir_hack=' - s&@datadir@&$datadir&g - s&@docdir@&$docdir&g - s&@infodir@&$infodir&g - s&@localedir@&$localedir&g - s&@mandir@&$mandir&g - s&\\\${datarootdir}&$datarootdir&g' ;; -esac -_ACEOF - -# Neutralize VPATH when `$srcdir' = `.'. -# Shell code in configure.ac might set extrasub. -# FIXME: do we really want to maintain this feature? -cat >>$CONFIG_STATUS <<_ACEOF || ac_write_fail=1 -ac_sed_extra="$ac_vpsub -$extrasub -_ACEOF -cat >>$CONFIG_STATUS <<\_ACEOF || ac_write_fail=1 -:t -/@[a-zA-Z_][a-zA-Z_0-9]*@/!b -s|@configure_input@|$ac_sed_conf_input|;t t -s&@top_builddir@&$ac_top_builddir_sub&;t t -s&@top_build_prefix@&$ac_top_build_prefix&;t t -s&@srcdir@&$ac_srcdir&;t t -s&@abs_srcdir@&$ac_abs_srcdir&;t t -s&@top_srcdir@&$ac_top_srcdir&;t t -s&@abs_top_srcdir@&$ac_abs_top_srcdir&;t t -s&@builddir@&$ac_builddir&;t t -s&@abs_builddir@&$ac_abs_builddir&;t t -s&@abs_top_builddir@&$ac_abs_top_builddir&;t t -s&@INSTALL@&$ac_INSTALL&;t t -s&@MKDIR_P@&$ac_MKDIR_P&;t t -$ac_datarootdir_hack -" -eval sed \"\$ac_sed_extra\" "$ac_file_inputs" | $AWK -f "$ac_tmp/subs.awk" \ - >$ac_tmp/out || as_fn_error $? "could not create $ac_file" "$LINENO" 5 - -test -z "$ac_datarootdir_hack$ac_datarootdir_seen" && - { ac_out=`sed -n '/\${datarootdir}/p' "$ac_tmp/out"`; test -n "$ac_out"; } && - { ac_out=`sed -n '/^[ ]*datarootdir[ ]*:*=/p' \ - "$ac_tmp/out"`; test -z "$ac_out"; } && - { $as_echo "$as_me:${as_lineno-$LINENO}: WARNING: $ac_file contains a reference to the variable \`datarootdir' -which seems to be undefined. Please make sure it is defined" >&5 -$as_echo "$as_me: WARNING: $ac_file contains a reference to the variable \`datarootdir' -which seems to be undefined. Please make sure it is defined" >&2;} - - rm -f "$ac_tmp/stdin" - case $ac_file in - -) cat "$ac_tmp/out" && rm -f "$ac_tmp/out";; - *) rm -f "$ac_file" && mv "$ac_tmp/out" "$ac_file";; - esac \ - || as_fn_error $? "could not create $ac_file" "$LINENO" 5 - ;; - :H) - # - # CONFIG_HEADER - # - if test x"$ac_file" != x-; then - { - $as_echo "/* $configure_input */" \ - && eval '$AWK -f "$ac_tmp/defines.awk"' "$ac_file_inputs" - } >"$ac_tmp/config.h" \ - || as_fn_error $? "could not create $ac_file" "$LINENO" 5 - if diff "$ac_file" "$ac_tmp/config.h" >/dev/null 2>&1; then - { $as_echo "$as_me:${as_lineno-$LINENO}: $ac_file is unchanged" >&5 -$as_echo "$as_me: $ac_file is unchanged" >&6;} - else - rm -f "$ac_file" - mv "$ac_tmp/config.h" "$ac_file" \ - || as_fn_error $? "could not create $ac_file" "$LINENO" 5 - fi - else - $as_echo "/* $configure_input */" \ - && eval '$AWK -f "$ac_tmp/defines.awk"' "$ac_file_inputs" \ - || as_fn_error $? "could not create -" "$LINENO" 5 - fi -# Compute "$ac_file"'s index in $config_headers. -_am_arg="$ac_file" -_am_stamp_count=1 -for _am_header in $config_headers :; do - case $_am_header in - $_am_arg | $_am_arg:* ) - break ;; - * ) - _am_stamp_count=`expr $_am_stamp_count + 1` ;; - esac -done -echo "timestamp for $_am_arg" >`$as_dirname -- "$_am_arg" || -$as_expr X"$_am_arg" : 'X\(.*[^/]\)//*[^/][^/]*/*$' \| \ - X"$_am_arg" : 'X\(//\)[^/]' \| \ - X"$_am_arg" : 'X\(//\)$' \| \ - X"$_am_arg" : 'X\(/\)' \| . 2>/dev/null || -$as_echo X"$_am_arg" | - sed '/^X\(.*[^/]\)\/\/*[^/][^/]*\/*$/{ - s//\1/ - q - } - /^X\(\/\/\)[^/].*/{ - s//\1/ - q - } - /^X\(\/\/\)$/{ - s//\1/ - q - } - /^X\(\/\).*/{ - s//\1/ - q - } - s/.*/./; q'`/stamp-h$_am_stamp_count - ;; - - :C) { $as_echo "$as_me:${as_lineno-$LINENO}: executing $ac_file commands" >&5 -$as_echo "$as_me: executing $ac_file commands" >&6;} - ;; - esac - - - case $ac_file$ac_mode in - "depfiles":C) test x"$AMDEP_TRUE" != x"" || { - # Older Autoconf quotes --file arguments for eval, but not when files - # are listed without --file. Let's play safe and only enable the eval - # if we detect the quoting. - case $CONFIG_FILES in - *\'*) eval set x "$CONFIG_FILES" ;; - *) set x $CONFIG_FILES ;; - esac - shift - for mf - do - # Strip MF so we end up with the name of the file. - mf=`echo "$mf" | sed -e 's/:.*$//'` - # Check whether this is an Automake generated Makefile or not. - # We used to match only the files named 'Makefile.in', but - # some people rename them; so instead we look at the file content. - # Grep'ing the first line is not enough: some people post-process - # each Makefile.in and add a new line on top of each file to say so. - # Grep'ing the whole file is not good either: AIX grep has a line - # limit of 2048, but all sed's we know have understand at least 4000. - if sed -n 's,^#.*generated by automake.*,X,p' "$mf" | grep X >/dev/null 2>&1; then - dirpart=`$as_dirname -- "$mf" || -$as_expr X"$mf" : 'X\(.*[^/]\)//*[^/][^/]*/*$' \| \ - X"$mf" : 'X\(//\)[^/]' \| \ - X"$mf" : 'X\(//\)$' \| \ - X"$mf" : 'X\(/\)' \| . 2>/dev/null || -$as_echo X"$mf" | - sed '/^X\(.*[^/]\)\/\/*[^/][^/]*\/*$/{ - s//\1/ - q - } - /^X\(\/\/\)[^/].*/{ - s//\1/ - q - } - /^X\(\/\/\)$/{ - s//\1/ - q - } - /^X\(\/\).*/{ - s//\1/ - q - } - s/.*/./; q'` - else - continue - fi - # Extract the definition of DEPDIR, am__include, and am__quote - # from the Makefile without running 'make'. - DEPDIR=`sed -n 's/^DEPDIR = //p' < "$mf"` - test -z "$DEPDIR" && continue - am__include=`sed -n 's/^am__include = //p' < "$mf"` - test -z "$am__include" && continue - am__quote=`sed -n 's/^am__quote = //p' < "$mf"` - # Find all dependency output files, they are included files with - # $(DEPDIR) in their names. We invoke sed twice because it is the - # simplest approach to changing $(DEPDIR) to its actual value in the - # expansion. - for file in `sed -n " - s/^$am__include $am__quote\(.*(DEPDIR).*\)$am__quote"'$/\1/p' <"$mf" | \ - sed -e 's/\$(DEPDIR)/'"$DEPDIR"'/g'`; do - # Make sure the directory exists. - test -f "$dirpart/$file" && continue - fdir=`$as_dirname -- "$file" || -$as_expr X"$file" : 'X\(.*[^/]\)//*[^/][^/]*/*$' \| \ - X"$file" : 'X\(//\)[^/]' \| \ - X"$file" : 'X\(//\)$' \| \ - X"$file" : 'X\(/\)' \| . 2>/dev/null || -$as_echo X"$file" | - sed '/^X\(.*[^/]\)\/\/*[^/][^/]*\/*$/{ - s//\1/ - q - } - /^X\(\/\/\)[^/].*/{ - s//\1/ - q - } - /^X\(\/\/\)$/{ - s//\1/ - q - } - /^X\(\/\).*/{ - s//\1/ - q - } - s/.*/./; q'` - as_dir=$dirpart/$fdir; as_fn_mkdir_p - # echo "creating $dirpart/$file" - echo '# dummy' > "$dirpart/$file" - done - done -} - ;; - - esac -done # for ac_tag - - -as_fn_exit 0 -_ACEOF -ac_clean_files=$ac_clean_files_save - -test $ac_write_fail = 0 || - as_fn_error $? "write failure creating $CONFIG_STATUS" "$LINENO" 5 - - -# configure is writing to config.log, and then calls config.status. -# config.status does its own redirection, appending to config.log. -# Unfortunately, on DOS this fails, as config.log is still kept open -# by configure, so config.status won't be able to write to it; its -# output is simply discarded. So we exec the FD to /dev/null, -# effectively closing config.log, so it can be properly (re)opened and -# appended to by config.status. When coming back to configure, we -# need to make the FD available again. -if test "$no_create" != yes; then - ac_cs_success=: - ac_config_status_args= - test "$silent" = yes && - ac_config_status_args="$ac_config_status_args --quiet" - exec 5>/dev/null - $SHELL $CONFIG_STATUS $ac_config_status_args || ac_cs_success=false - exec 5>>config.log - # Use ||, not &&, to avoid exiting from the if with $? = 1, which - # would make configure fail if this is the last instruction. - $ac_cs_success || as_fn_exit 1 -fi -if test -n "$ac_unrecognized_opts" && test "$enable_option_checking" != no; then - { $as_echo "$as_me:${as_lineno-$LINENO}: WARNING: unrecognized options: $ac_unrecognized_opts" >&5 -$as_echo "$as_me: WARNING: unrecognized options: $ac_unrecognized_opts" >&2;} -fi - - -echo -echo " Configured Munipack:" -echo -echo " Virtual Observatory support enabled: ${wxVO}" -echo " Command line interface enabled: ${wxCLI}" -echo " Graphical User Interface enabled: ${wxGUI}" -echo " Bundle installation: ${enable_bundle}" -if test "x$enable_bundle" = "xyes"; then -echo " BUNDLEDIR= ${BUNDLEDIR}" -fi -echo diff -Nru munipack-0.5.9/autom4te.cache/requests munipack-0.5.10/autom4te.cache/requests --- munipack-0.5.9/autom4te.cache/requests 2017-07-17 23:04:25.000000000 +0000 +++ munipack-0.5.10/autom4te.cache/requests 1970-01-01 00:00:00.000000000 +0000 @@ -1,174 +0,0 @@ -# This file was generated by Autom4te Sat Mar 26 18:08:30 UTC 2016. -# It contains the lists of macros which have been traced. -# It can be safely removed. - -@request = ( - bless( [ - '0', - 1, - [ - '/usr/share/autoconf' - ], - [ - '/usr/share/autoconf/autoconf/autoconf.m4f', - '-', - '/usr/share/aclocal-1.15/internal/ac-config-macro-dirs.m4', - '/usr/share/aclocal/wxwin.m4', - '/usr/share/aclocal-1.15/amversion.m4', - '/usr/share/aclocal-1.15/auxdir.m4', - '/usr/share/aclocal-1.15/cond.m4', - '/usr/share/aclocal-1.15/depend.m4', - '/usr/share/aclocal-1.15/depout.m4', - '/usr/share/aclocal-1.15/init.m4', - '/usr/share/aclocal-1.15/install-sh.m4', - '/usr/share/aclocal-1.15/lead-dot.m4', - '/usr/share/aclocal-1.15/make.m4', - '/usr/share/aclocal-1.15/missing.m4', - '/usr/share/aclocal-1.15/options.m4', - '/usr/share/aclocal-1.15/prog-cc-c-o.m4', - '/usr/share/aclocal-1.15/runlog.m4', - '/usr/share/aclocal-1.15/sanity.m4', - '/usr/share/aclocal-1.15/silent.m4', - '/usr/share/aclocal-1.15/strip.m4', - '/usr/share/aclocal-1.15/substnot.m4', - '/usr/share/aclocal-1.15/tar.m4', - 'configure.ac' - ], - { - '_m4_warn' => 1, - 'AM_OPTIONS_WXCONFIG' => 1, - 'AM_RUN_LOG' => 1, - 'WX_CONFIG_CHECK' => 1, - 'WX_BOOLOPT_SUMMARY' => 1, - '_AM_PROG_TAR' => 1, - 'WX_LIKE_LIBNAME' => 1, - 'include' => 1, - 'WX_ARG_WITH_YESNOAUTO' => 1, - 'AM_AUTOMAKE_VERSION' => 1, - 'AM_MAKE_INCLUDE' => 1, - 'WX_CONVERT_STANDARD_OPTIONS_TO_WXCONFIG_FLAGS' => 1, - 'AM_PROG_CC_C_O' => 1, - 'm4_include' => 1, - '_AM_MANGLE_OPTION' => 1, - 'AM_PATH_WXCONFIG' => 1, - 'AM_SET_DEPDIR' => 1, - 'WX_CONFIG_OPTIONS' => 1, - 'AM_OUTPUT_DEPENDENCY_COMMANDS' => 1, - '_AM_AUTOCONF_VERSION' => 1, - '_AM_SUBST_NOTMAKE' => 1, - '_AC_AM_CONFIG_HEADER_HOOK' => 1, - 'AM_PATH_WXRC' => 1, - 'WX_DETECT_STANDARD_OPTION_VALUES' => 1, - 'AM_SUBST_NOTMAKE' => 1, - '_AM_PROG_CC_C_O' => 1, - 'AM_SILENT_RULES' => 1, - 'AM_SANITY_CHECK' => 1, - 'AM_PROG_INSTALL_SH' => 1, - 'AC_CONFIG_MACRO_DIR_TRACE' => 1, - 'WX_STANDARD_OPTIONS_SUMMARY_MSG_BEGIN' => 1, - '_WX_SELECTEDCONFIG_CHECKFOR' => 1, - '_AM_OUTPUT_DEPENDENCY_COMMANDS' => 1, - 'AC_DEFUN_ONCE' => 1, - 'AM_PROG_INSTALL_STRIP' => 1, - 'AM_DEP_TRACK' => 1, - '_AM_SET_OPTIONS' => 1, - 'AM_MISSING_PROG' => 1, - 'AM_INIT_AUTOMAKE' => 1, - 'AM_AUX_DIR_EXPAND' => 1, - 'AM_CONDITIONAL' => 1, - 'm4_pattern_allow' => 1, - 'AM_SET_LEADING_DOT' => 1, - 'WX_STANDARD_OPTIONS_SUMMARY_MSG_END' => 1, - 'WX_ARG_ENABLE_YESNOAUTO' => 1, - 'AM_MISSING_HAS_RUN' => 1, - '_WX_PRIVATE_CHECK_VERSION' => 1, - 'WXRC_CHECK' => 1, - 'AC_CONFIG_MACRO_DIR' => 1, - '_AM_SET_OPTION' => 1, - '_AM_IF_OPTION' => 1, - 'WX_STANDARD_OPTIONS' => 1, - '_AM_DEPENDENCIES' => 1, - 'AC_DEFUN' => 1, - 'm4_pattern_forbid' => 1, - '_AM_CONFIG_MACRO_DIRS' => 1, - 'AU_DEFUN' => 1, - 'WX_STANDARD_OPTIONS_SUMMARY_MSG' => 1, - 'AM_SET_CURRENT_AUTOMAKE_VERSION' => 1 - } - ], 'Autom4te::Request' ), - bless( [ - '1', - 1, - [ - '/usr/share/autoconf' - ], - [ - '/usr/share/autoconf/autoconf/autoconf.m4f', - 'aclocal.m4', - 'configure.ac' - ], - { - 'AM_PROG_FC_C_O' => 1, - 'AM_NLS' => 1, - 'AC_CONFIG_HEADERS' => 1, - 'm4_pattern_forbid' => 1, - 'AC_INIT' => 1, - 'AC_FC_FREEFORM' => 1, - 'AC_CANONICAL_TARGET' => 1, - 'AM_POT_TOOLS' => 1, - 'AC_SUBST_TRACE' => 1, - '_AM_COND_ELSE' => 1, - 'AM_ENABLE_MULTILIB' => 1, - 'LT_SUPPORTED_TAG' => 1, - 'm4_pattern_allow' => 1, - 'AM_CONDITIONAL' => 1, - 'AM_MAINTAINER_MODE' => 1, - 'AC_SUBST' => 1, - '_AM_MAKEFILE_INCLUDE' => 1, - 'AM_MAKEFILE_INCLUDE' => 1, - 'sinclude' => 1, - 'AC_CONFIG_LIBOBJ_DIR' => 1, - 'AM_INIT_AUTOMAKE' => 1, - 'AC_CONFIG_AUX_DIR' => 1, - 'AM_PROG_AR' => 1, - 'AM_PROG_LIBTOOL' => 1, - 'AC_PROG_LIBTOOL' => 1, - 'AC_DEFINE_TRACE_LITERAL' => 1, - 'AC_CONFIG_FILES' => 1, - '_AM_COND_IF' => 1, - 'AM_PATH_GUILE' => 1, - 'AC_CANONICAL_HOST' => 1, - 'AM_GNU_GETTEXT' => 1, - 'AC_FC_SRCEXT' => 1, - '_AM_COND_ENDIF' => 1, - '_AM_SUBST_NOTMAKE' => 1, - 'AM_PROG_F77_C_O' => 1, - 'AM_PROG_CC_C_O' => 1, - 'm4_include' => 1, - 'AM_GNU_GETTEXT_INTL_SUBDIR' => 1, - 'AM_XGETTEXT_OPTION' => 1, - 'AM_PROG_MOC' => 1, - 'AC_CANONICAL_BUILD' => 1, - 'AM_PROG_MKDIR_P' => 1, - 'AC_REQUIRE_AUX_FILE' => 1, - 'AM_SILENT_RULES' => 1, - 'm4_sinclude' => 1, - 'AM_EXTRA_RECURSIVE_TARGETS' => 1, - 'LT_CONFIG_LTDL_DIR' => 1, - 'AC_CONFIG_LINKS' => 1, - 'AC_LIBSOURCE' => 1, - 'AC_FC_PP_DEFINE' => 1, - 'AC_CANONICAL_SYSTEM' => 1, - '_m4_warn' => 1, - 'AC_FC_PP_SRCEXT' => 1, - 'AM_PROG_CXX_C_O' => 1, - 'AM_AUTOMAKE_VERSION' => 1, - 'AH_OUTPUT' => 1, - '_LT_AC_TAGCONFIG' => 1, - 'include' => 1, - 'AC_CONFIG_SUBDIRS' => 1, - 'LT_INIT' => 1 - } - ], 'Autom4te::Request' ) - ); - diff -Nru munipack-0.5.9/autom4te.cache/traces.0 munipack-0.5.10/autom4te.cache/traces.0 --- munipack-0.5.9/autom4te.cache/traces.0 2017-07-17 23:04:24.000000000 +0000 +++ munipack-0.5.10/autom4te.cache/traces.0 1970-01-01 00:00:00.000000000 +0000 @@ -1,1784 +0,0 @@ -m4trace:/usr/share/aclocal/wxwin.m4:101: -1- AC_DEFUN([WX_CONFIG_OPTIONS], [ - AC_ARG_WITH(wxdir, - [ --with-wxdir=PATH Use uninstalled version of wxWidgets in PATH], - [ wx_config_name="$withval/wx-config" - wx_config_args="--inplace"]) - AC_ARG_WITH(wx-config, - [ --with-wx-config=CONFIG wx-config script to use (optional)], - wx_config_name="$withval" ) - AC_ARG_WITH(wx-prefix, - [ --with-wx-prefix=PREFIX Prefix where wxWidgets is installed (optional)], - wx_config_prefix="$withval", wx_config_prefix="") - AC_ARG_WITH(wx-exec-prefix, - [ --with-wx-exec-prefix=PREFIX - Exec prefix where wxWidgets is installed (optional)], - wx_config_exec_prefix="$withval", wx_config_exec_prefix="") -]) -m4trace:/usr/share/aclocal/wxwin.m4:121: -1- AC_DEFUN([_WX_PRIVATE_CHECK_VERSION], [ - wx_ver_ok="" - if test "x$WX_VERSION" != x ; then - if test $wx_config_major_version -gt $1; then - wx_ver_ok=yes - else - if test $wx_config_major_version -eq $1; then - if test $wx_config_minor_version -gt $2; then - wx_ver_ok=yes - else - if test $wx_config_minor_version -eq $2; then - if test $wx_config_micro_version -ge $3; then - wx_ver_ok=yes - fi - fi - fi - fi - fi - fi -]) -m4trace:/usr/share/aclocal/wxwin.m4:170: -1- AC_DEFUN([WX_CONFIG_CHECK], [ - dnl do we have wx-config name: it can be wx-config or wxd-config or ... - if test x${WX_CONFIG_NAME+set} != xset ; then - WX_CONFIG_NAME=wx-config - fi - - if test "x$wx_config_name" != x ; then - WX_CONFIG_NAME="$wx_config_name" - fi - - dnl deal with optional prefixes - if test x$wx_config_exec_prefix != x ; then - wx_config_args="$wx_config_args --exec-prefix=$wx_config_exec_prefix" - WX_LOOKUP_PATH="$wx_config_exec_prefix/bin" - fi - if test x$wx_config_prefix != x ; then - wx_config_args="$wx_config_args --prefix=$wx_config_prefix" - WX_LOOKUP_PATH="$WX_LOOKUP_PATH:$wx_config_prefix/bin" - fi - if test "$cross_compiling" = "yes"; then - wx_config_args="$wx_config_args --host=$host_alias" - fi - - dnl don't search the PATH if WX_CONFIG_NAME is absolute filename - if test -x "$WX_CONFIG_NAME" ; then - AC_MSG_CHECKING(for wx-config) - WX_CONFIG_PATH="$WX_CONFIG_NAME" - AC_MSG_RESULT($WX_CONFIG_PATH) - else - AC_PATH_PROG(WX_CONFIG_PATH, $WX_CONFIG_NAME, no, "$WX_LOOKUP_PATH:$PATH") - fi - - if test "$WX_CONFIG_PATH" != "no" ; then - WX_VERSION="" - - min_wx_version=ifelse([$1], ,2.2.1,$1) - if test -z "$5" ; then - AC_MSG_CHECKING([for wxWidgets version >= $min_wx_version]) - else - AC_MSG_CHECKING([for wxWidgets version >= $min_wx_version ($5)]) - fi - - dnl don't add the libraries ($4) to this variable as this would result in - dnl an error when it's used with --version below - WX_CONFIG_WITH_ARGS="$WX_CONFIG_PATH $wx_config_args $5" - - WX_VERSION=`$WX_CONFIG_WITH_ARGS --version 2>/dev/null` - wx_config_major_version=`echo $WX_VERSION | \ - sed 's/\([[0-9]]*\).\([[0-9]]*\).\([[0-9]]*\)/\1/'` - wx_config_minor_version=`echo $WX_VERSION | \ - sed 's/\([[0-9]]*\).\([[0-9]]*\).\([[0-9]]*\)/\2/'` - wx_config_micro_version=`echo $WX_VERSION | \ - sed 's/\([[0-9]]*\).\([[0-9]]*\).\([[0-9]]*\)/\3/'` - - wx_requested_major_version=`echo $min_wx_version | \ - sed 's/\([[0-9]]*\).\([[0-9]]*\).\([[0-9]]*\)/\1/'` - wx_requested_minor_version=`echo $min_wx_version | \ - sed 's/\([[0-9]]*\).\([[0-9]]*\).\([[0-9]]*\)/\2/'` - wx_requested_micro_version=`echo $min_wx_version | \ - sed 's/\([[0-9]]*\).\([[0-9]]*\).\([[0-9]]*\)/\3/'` - - _WX_PRIVATE_CHECK_VERSION([$wx_requested_major_version], - [$wx_requested_minor_version], - [$wx_requested_micro_version]) - - if test -n "$wx_ver_ok"; then - AC_MSG_RESULT(yes (version $WX_VERSION)) - WX_LIBS=`$WX_CONFIG_WITH_ARGS --libs $4` - - dnl is this even still appropriate? --static is a real option now - dnl and WX_CONFIG_WITH_ARGS is likely to contain it if that is - dnl what the user actually wants, making this redundant at best. - dnl For now keep it in case anyone actually used it in the past. - AC_MSG_CHECKING([for wxWidgets static library]) - WX_LIBS_STATIC=`$WX_CONFIG_WITH_ARGS --static --libs $4 2>/dev/null` - if test "x$WX_LIBS_STATIC" = "x"; then - AC_MSG_RESULT(no) - else - AC_MSG_RESULT(yes) - fi - - dnl starting with version 2.2.6 wx-config has --cppflags argument - wx_has_cppflags="" - if test $wx_config_major_version -gt 2; then - wx_has_cppflags=yes - else - if test $wx_config_major_version -eq 2; then - if test $wx_config_minor_version -gt 2; then - wx_has_cppflags=yes - else - if test $wx_config_minor_version -eq 2; then - if test $wx_config_micro_version -ge 6; then - wx_has_cppflags=yes - fi - fi - fi - fi - fi - - dnl starting with version 2.7.0 wx-config has --rescomp option - wx_has_rescomp="" - if test $wx_config_major_version -gt 2; then - wx_has_rescomp=yes - else - if test $wx_config_major_version -eq 2; then - if test $wx_config_minor_version -ge 7; then - wx_has_rescomp=yes - fi - fi - fi - if test "x$wx_has_rescomp" = x ; then - dnl cannot give any useful info for resource compiler - WX_RESCOMP= - else - WX_RESCOMP=`$WX_CONFIG_WITH_ARGS --rescomp` - fi - - if test "x$wx_has_cppflags" = x ; then - dnl no choice but to define all flags like CFLAGS - WX_CFLAGS=`$WX_CONFIG_WITH_ARGS --cflags $4` - WX_CPPFLAGS=$WX_CFLAGS - WX_CXXFLAGS=$WX_CFLAGS - - WX_CFLAGS_ONLY=$WX_CFLAGS - WX_CXXFLAGS_ONLY=$WX_CFLAGS - else - dnl we have CPPFLAGS included in CFLAGS included in CXXFLAGS - WX_CPPFLAGS=`$WX_CONFIG_WITH_ARGS --cppflags $4` - WX_CXXFLAGS=`$WX_CONFIG_WITH_ARGS --cxxflags $4` - WX_CFLAGS=`$WX_CONFIG_WITH_ARGS --cflags $4` - - WX_CFLAGS_ONLY=`echo $WX_CFLAGS | sed "s@^$WX_CPPFLAGS *@@"` - WX_CXXFLAGS_ONLY=`echo $WX_CXXFLAGS | sed "s@^$WX_CFLAGS *@@"` - fi - - ifelse([$2], , :, [$2]) - - else - - if test "x$WX_VERSION" = x; then - dnl no wx-config at all - AC_MSG_RESULT(no) - else - AC_MSG_RESULT(no (version $WX_VERSION is not new enough)) - fi - - WX_CFLAGS="" - WX_CPPFLAGS="" - WX_CXXFLAGS="" - WX_LIBS="" - WX_LIBS_STATIC="" - WX_RESCOMP="" - - if test ! -z "$5"; then - - wx_error_message=" - The configuration you asked for $PACKAGE_NAME requires a wxWidgets - build with the following settings: - $5 - but such build is not available. - - To see the wxWidgets builds available on this system, please use - 'wx-config --list' command. To use the default build, returned by - 'wx-config --selected-config', use the options with their 'auto' - default values." - - fi - - wx_error_message=" - The requested wxWidgets build couldn't be found. - $wx_error_message - - If you still get this error, then check that 'wx-config' is - in path, the directory where wxWidgets libraries are installed - (returned by 'wx-config --libs' command) is in LD_LIBRARY_PATH - or equivalent variable and wxWidgets version is $1 or above." - - ifelse([$3], , AC_MSG_ERROR([$wx_error_message]), [$3]) - - fi - else - - WX_CFLAGS="" - WX_CPPFLAGS="" - WX_CXXFLAGS="" - WX_LIBS="" - WX_LIBS_STATIC="" - WX_RESCOMP="" - - ifelse([$3], , :, [$3]) - - fi - - AC_SUBST(WX_CPPFLAGS) - AC_SUBST(WX_CFLAGS) - AC_SUBST(WX_CXXFLAGS) - AC_SUBST(WX_CFLAGS_ONLY) - AC_SUBST(WX_CXXFLAGS_ONLY) - AC_SUBST(WX_LIBS) - AC_SUBST(WX_LIBS_STATIC) - AC_SUBST(WX_VERSION) - AC_SUBST(WX_RESCOMP) - - dnl need to export also WX_VERSION_MINOR and WX_VERSION_MAJOR symbols - dnl to support wxpresets bakefiles (we export also WX_VERSION_MICRO for completeness): - WX_VERSION_MAJOR="$wx_config_major_version" - WX_VERSION_MINOR="$wx_config_minor_version" - WX_VERSION_MICRO="$wx_config_micro_version" - AC_SUBST(WX_VERSION_MAJOR) - AC_SUBST(WX_VERSION_MINOR) - AC_SUBST(WX_VERSION_MICRO) -]) -m4trace:/usr/share/aclocal/wxwin.m4:436: -1- AC_DEFUN([WXRC_CHECK], [ - AC_ARG_VAR([WXRC], [Path to wxWidget's wxrc resource compiler]) - - if test "x$WX_CONFIG_NAME" = x; then - AC_MSG_ERROR([The wxrc tests must run after wxWidgets test.]) - else - - AC_MSG_CHECKING([for wxrc]) - - if test "x$WXRC" = x ; then - dnl wx-config --utility is a new addition to wxWidgets: - _WX_PRIVATE_CHECK_VERSION(2,5,3) - if test -n "$wx_ver_ok"; then - WXRC=`$WX_CONFIG_WITH_ARGS --utility=wxrc` - fi - fi - - if test "x$WXRC" = x ; then - AC_MSG_RESULT([not found]) - ifelse([$2], , :, [$2]) - else - AC_MSG_RESULT([$WXRC]) - ifelse([$1], , :, [$1]) - fi - - AC_SUBST(WXRC) - fi -]) -m4trace:/usr/share/aclocal/wxwin.m4:476: -1- AC_DEFUN([WX_LIKE_LIBNAME], [ - wx_temp="$2""_""$WX_PORT" - - dnl add the [u][d] string - if test "$WX_UNICODE" = "1"; then - wx_temp="$wx_temp""u" - fi - if test "$WX_DEBUG" = "1"; then - wx_temp="$wx_temp""d" - fi - - dnl complete the name of the lib - wx_temp="$wx_temp""_""$3""-$WX_VERSION_MAJOR.$WX_VERSION_MINOR" - - dnl save it in the user's variable - $1=$wx_temp - ]) -m4trace:/usr/share/aclocal/wxwin.m4:506: -1- AC_DEFUN([WX_ARG_ENABLE_YESNOAUTO], [AC_ARG_ENABLE($1, - AC_HELP_STRING([--enable-$1], [$3 (default is $4)]), - [], [enableval="$4"]) - - dnl Show a message to the user about this option - AC_MSG_CHECKING([for the --enable-$1 option]) - if test "$enableval" = "yes" ; then - AC_MSG_RESULT([yes]) - $2=1 - $5 - elif test "$enableval" = "no" ; then - AC_MSG_RESULT([no]) - $2=0 - elif test "$enableval" = "auto" ; then - AC_MSG_RESULT([will be automatically detected]) - $2="auto" - else - AC_MSG_ERROR([ - Unrecognized option value (allowed values: yes, no, auto) - ]) - fi - ]) -m4trace:/usr/share/aclocal/wxwin.m4:530: -1- AC_DEFUN([WX_ARG_WITH_YESNOAUTO], [AC_ARG_WITH($1, - AC_HELP_STRING([--with-$1], [$3 (default is $4)]), - [], [withval="$4"]) - - dnl Show a message to the user about this option - AC_MSG_CHECKING([for the --with-$1 option]) - if test "$withval" = "yes" ; then - AC_MSG_RESULT([yes]) - $2=1 - $5 - dnl NB: by default we don't allow --with-$1=no option - dnl since it does not make much sense ! - elif test "$6" = "1" -a "$withval" = "no" ; then - AC_MSG_RESULT([no]) - $2=0 - elif test "$withval" = "auto" ; then - AC_MSG_RESULT([will be automatically detected]) - $2="auto" - else - AC_MSG_ERROR([ - Unrecognized option value (allowed values: yes, auto) - ]) - fi - ]) -m4trace:/usr/share/aclocal/wxwin.m4:571: -1- AC_DEFUN([WX_STANDARD_OPTIONS], [ - - dnl the following lines will expand to WX_ARG_ENABLE_YESNOAUTO calls if and only if - dnl the $1 argument contains respectively the debug,unicode or shared options. - - dnl be careful here not to set debug flag if only "wxdebug" was specified - ifelse(regexp([$1], [\bdebug]), [-1],, - [WX_ARG_ENABLE_YESNOAUTO([debug], [DEBUG], [Build in debug mode], [auto])]) - - ifelse(index([$1], [unicode]), [-1],, - [WX_ARG_ENABLE_YESNOAUTO([unicode], [UNICODE], [Build in Unicode mode], [auto])]) - - ifelse(regexp([$1], [\bshared]), [-1],, - [WX_ARG_ENABLE_YESNOAUTO([shared], [SHARED], [Build as shared library], [auto])]) - - dnl WX_ARG_WITH_YESNOAUTO cannot be used for --with-toolkit since it's an option - dnl which must be able to accept the auto|gtk1|gtk2|msw|... values - ifelse(index([$1], [toolkit]), [-1],, - [ - AC_ARG_WITH([toolkit], - AC_HELP_STRING([--with-toolkit], - [Build against a specific wxWidgets toolkit (default is auto)]), - [], [withval="auto"]) - - dnl Show a message to the user about this option - AC_MSG_CHECKING([for the --with-toolkit option]) - if test "$withval" = "auto" ; then - AC_MSG_RESULT([will be automatically detected]) - TOOLKIT="auto" - else - TOOLKIT="$withval" - - dnl PORT must be one of the allowed values - if test "$TOOLKIT" != "gtk1" -a "$TOOLKIT" != "gtk2" -a \ - "$TOOLKIT" != "msw" -a "$TOOLKIT" != "motif" -a \ - "$TOOLKIT" != "osx_carbon" -a "$TOOLKIT" != "osx_cocoa" -a \ - "$TOOLKIT" != "dfb" -a "$TOOLKIT" != "x11"; then - AC_MSG_ERROR([ - Unrecognized option value (allowed values: auto, gtk1, gtk2, msw, motif, osx_carbon, osx_cocoa, dfb, x11) - ]) - fi - - AC_MSG_RESULT([$TOOLKIT]) - fi - ]) - - dnl ****** IMPORTANT ******* - dnl Unlike for the UNICODE setting, you can build your program in - dnl shared mode against a static build of wxWidgets. Thus we have the - dnl following option which allows these mixtures. E.g. - dnl - dnl ./configure --disable-shared --with-wxshared - dnl - dnl will build your library in static mode against the first available - dnl shared build of wxWidgets. - dnl - dnl Note that's not possible to do the viceversa: - dnl - dnl ./configure --enable-shared --without-wxshared - dnl - dnl Doing so you would try to build your library in shared mode against a static - dnl build of wxWidgets. This is not possible (you would mix PIC and non PIC code) ! - dnl A check for this combination of options is in WX_DETECT_STANDARD_OPTION_VALUES - dnl (where we know what 'auto' should be expanded to). - dnl - dnl If you try to build something in ANSI mode against a UNICODE build - dnl of wxWidgets or in RELEASE mode against a DEBUG build of wxWidgets, - dnl then at best you'll get ton of linking errors ! - dnl ************************ - - ifelse(index([$1], [wxshared]), [-1],, - [ - WX_ARG_WITH_YESNOAUTO( - [wxshared], [WX_SHARED], - [Force building against a shared build of wxWidgets, even if --disable-shared is given], - [auto], [], [1]) - ]) - - dnl Just like for SHARED and WX_SHARED it may happen that some adventurous - dnl peoples will want to mix a wxWidgets release build with a debug build of - dnl his app/lib. So, we have both DEBUG and WX_DEBUG variables. - ifelse(index([$1], [wxdebug]), [-1],, - [ - WX_ARG_WITH_YESNOAUTO( - [wxdebug], [WX_DEBUG], - [Force building against a debug build of wxWidgets, even if --disable-debug is given], - [auto], [], [1]) - ]) - - dnl WX_ARG_WITH_YESNOAUTO cannot be used for --with-wxversion since it's an option - dnl which accepts the "auto|2.6|2.7|2.8|2.9|3.0" etc etc values - ifelse(index([$1], [wxversion]), [-1],, - [ - AC_ARG_WITH([wxversion], - AC_HELP_STRING([--with-wxversion], - [Build against a specific version of wxWidgets (default is auto)]), - [], [withval="auto"]) - - dnl Show a message to the user about this option - AC_MSG_CHECKING([for the --with-wxversion option]) - if test "$withval" = "auto" ; then - AC_MSG_RESULT([will be automatically detected]) - WX_RELEASE="auto" - else - - wx_requested_major_version=`echo $withval | \ - sed 's/\([[0-9]]*\).\([[0-9]]*\).*/\1/'` - wx_requested_minor_version=`echo $withval | \ - sed 's/\([[0-9]]*\).\([[0-9]]*\).*/\2/'` - - dnl both vars above must be exactly 1 digit - if test "${#wx_requested_major_version}" != "1" -o \ - "${#wx_requested_minor_version}" != "1" ; then - AC_MSG_ERROR([ - Unrecognized option value (allowed values: auto, 2.6, 2.7, 2.8, 2.9, 3.0) - ]) - fi - - WX_RELEASE="$wx_requested_major_version"".""$wx_requested_minor_version" - AC_MSG_RESULT([$WX_RELEASE]) - fi - ]) - - if test "$WX_DEBUG_CONFIGURE" = "1"; then - echo "[[dbg]] DEBUG: $DEBUG, WX_DEBUG: $WX_DEBUG" - echo "[[dbg]] UNICODE: $UNICODE, WX_UNICODE: $WX_UNICODE" - echo "[[dbg]] SHARED: $SHARED, WX_SHARED: $WX_SHARED" - echo "[[dbg]] TOOLKIT: $TOOLKIT, WX_TOOLKIT: $WX_TOOLKIT" - echo "[[dbg]] VERSION: $VERSION, WX_RELEASE: $WX_RELEASE" - fi - ]) -m4trace:/usr/share/aclocal/wxwin.m4:712: -1- AC_DEFUN([WX_CONVERT_STANDARD_OPTIONS_TO_WXCONFIG_FLAGS], [ - if test "$WX_SHARED" = "1" ; then - WXCONFIG_FLAGS="--static=no " - elif test "$WX_SHARED" = "0" ; then - WXCONFIG_FLAGS="--static=yes " - fi - - if test "$WX_DEBUG" = "1" ; then - WXCONFIG_FLAGS="$WXCONFIG_FLAGS""--debug=yes " - elif test "$WX_DEBUG" = "0" ; then - WXCONFIG_FLAGS="$WXCONFIG_FLAGS""--debug=no " - fi - - dnl The user should have set WX_UNICODE=UNICODE - if test "$WX_UNICODE" = "1" ; then - WXCONFIG_FLAGS="$WXCONFIG_FLAGS""--unicode=yes " - elif test "$WX_UNICODE" = "0" ; then - WXCONFIG_FLAGS="$WXCONFIG_FLAGS""--unicode=no " - fi - - if test "$TOOLKIT" != "auto" ; then - WXCONFIG_FLAGS="$WXCONFIG_FLAGS""--toolkit=$TOOLKIT " - fi - - if test "$WX_RELEASE" != "auto" ; then - WXCONFIG_FLAGS="$WXCONFIG_FLAGS""--version=$WX_RELEASE " - fi - - dnl strip out the last space of the string - WXCONFIG_FLAGS=${WXCONFIG_FLAGS% } - - if test "$WX_DEBUG_CONFIGURE" = "1"; then - echo "[[dbg]] WXCONFIG_FLAGS: $WXCONFIG_FLAGS" - fi - ]) -m4trace:/usr/share/aclocal/wxwin.m4:758: -1- AC_DEFUN([_WX_SELECTEDCONFIG_CHECKFOR], [ - if test "$$1" = "auto" ; then - - dnl The user does not have particular preferences for this option; - dnl so we will detect the wxWidgets relative build setting and use it - AC_MSG_CHECKING([$3]) - - dnl set WX_$1 variable to 1 if the $WX_SELECTEDCONFIG contains the $2 - dnl string or to 0 otherwise. - dnl NOTE: 'expr match STRING REGEXP' cannot be used since on Mac it - dnl doesn't work; we use 'expr STRING : REGEXP' instead - WX_$1=$(expr "$WX_SELECTEDCONFIG" : ".*$2.*") - - if test "$WX_$1" != "0"; then - WX_$1=1 - AC_MSG_RESULT([yes]) - ifelse([$4], , :, [$4]) - else - WX_$1=0 - AC_MSG_RESULT([no]) - ifelse([$5], , :, [$5]) - fi - else - - dnl Use the setting given by the user - WX_$1=$$1 - fi - ]) -m4trace:/usr/share/aclocal/wxwin.m4:803: -1- AC_DEFUN([WX_DETECT_STANDARD_OPTION_VALUES], [ - dnl IMPORTANT: WX_VERSION contains all three major.minor.micro digits, - dnl while WX_RELEASE only the major.minor ones. - WX_RELEASE="$WX_VERSION_MAJOR""$WX_VERSION_MINOR" - if test $WX_RELEASE -lt 26 ; then - - AC_MSG_ERROR([ - Cannot detect the wxWidgets configuration for the selected wxWidgets build - since its version is $WX_VERSION < 2.6.0; please install a newer - version of wxWidgets. - ]) - fi - - dnl The wx-config we are using understands the "--selected_config" - dnl option which returns an easy-parseable string ! - WX_SELECTEDCONFIG=$($WX_CONFIG_WITH_ARGS --selected_config) - - if test "$WX_DEBUG_CONFIGURE" = "1"; then - echo "[[dbg]] Using wx-config --selected-config" - echo "[[dbg]] WX_SELECTEDCONFIG: $WX_SELECTEDCONFIG" - fi - - - dnl we could test directly for WX_SHARED with a line like: - dnl _WX_SELECTEDCONFIG_CHECKFOR([SHARED], [shared], - dnl [if wxWidgets was built in SHARED mode]) - dnl but wx-config --selected-config DOES NOT outputs the 'shared' - dnl word when wx was built in shared mode; it rather outputs the - dnl 'static' word when built in static mode. - if test $WX_SHARED = "1"; then - STATIC=0 - elif test $WX_SHARED = "0"; then - STATIC=1 - elif test $WX_SHARED = "auto"; then - STATIC="auto" - fi - - dnl Now set the WX_UNICODE, WX_DEBUG, WX_STATIC variables - _WX_SELECTEDCONFIG_CHECKFOR([UNICODE], [unicode], - [if wxWidgets was built with UNICODE enabled]) - _WX_SELECTEDCONFIG_CHECKFOR([DEBUG], [debug], - [if wxWidgets was built in DEBUG mode]) - _WX_SELECTEDCONFIG_CHECKFOR([STATIC], [static], - [if wxWidgets was built in STATIC mode]) - - dnl init WX_SHARED from WX_STATIC - if test "$WX_STATIC" != "0"; then - WX_SHARED=0 - else - WX_SHARED=1 - fi - - AC_SUBST(WX_UNICODE) - AC_SUBST(WX_DEBUG) - AC_SUBST(WX_SHARED) - - dnl detect the WX_PORT to use - if test "$TOOLKIT" = "auto" ; then - - dnl The user does not have particular preferences for this option; - dnl so we will detect the wxWidgets relative build setting and use it - AC_MSG_CHECKING([which wxWidgets toolkit was selected]) - - WX_GTKPORT1=$(expr "$WX_SELECTEDCONFIG" : ".*gtk1.*") - WX_GTKPORT2=$(expr "$WX_SELECTEDCONFIG" : ".*gtk2.*") - WX_MSWPORT=$(expr "$WX_SELECTEDCONFIG" : ".*msw.*") - WX_MOTIFPORT=$(expr "$WX_SELECTEDCONFIG" : ".*motif.*") - WX_OSXCOCOAPORT=$(expr "$WX_SELECTEDCONFIG" : ".*osx_cocoa.*") - WX_OSXCARBONPORT=$(expr "$WX_SELECTEDCONFIG" : ".*osx_carbon.*") - WX_X11PORT=$(expr "$WX_SELECTEDCONFIG" : ".*x11.*") - WX_DFBPORT=$(expr "$WX_SELECTEDCONFIG" : ".*dfb.*") - - WX_PORT="unknown" - if test "$WX_GTKPORT1" != "0"; then WX_PORT="gtk1"; fi - if test "$WX_GTKPORT2" != "0"; then WX_PORT="gtk2"; fi - if test "$WX_MSWPORT" != "0"; then WX_PORT="msw"; fi - if test "$WX_MOTIFPORT" != "0"; then WX_PORT="motif"; fi - if test "$WX_OSXCOCOAPORT" != "0"; then WX_PORT="osx_cocoa"; fi - if test "$WX_OSXCARBONPORT" != "0"; then WX_PORT="osx_carbon"; fi - if test "$WX_X11PORT" != "0"; then WX_PORT="x11"; fi - if test "$WX_DFBPORT" != "0"; then WX_PORT="dfb"; fi - - dnl NOTE: backward-compatible check for wx2.8; in wx2.9 the mac - dnl ports are called 'osx_cocoa' and 'osx_carbon' (see above) - WX_MACPORT=$(expr "$WX_SELECTEDCONFIG" : ".*mac.*") - if test "$WX_MACPORT" != "0"; then WX_PORT="mac"; fi - - dnl check at least one of the WX_*PORT has been set ! - - if test "$WX_PORT" = "unknown" ; then - AC_MSG_ERROR([ - Cannot detect the currently installed wxWidgets port ! - Please check your 'wx-config --cxxflags'... - ]) - fi - - AC_MSG_RESULT([$WX_PORT]) - else - - dnl Use the setting given by the user - if test -z "$TOOLKIT" ; then - WX_PORT=$TOOLKIT - else - dnl try with PORT - WX_PORT=$PORT - fi - fi - - AC_SUBST(WX_PORT) - - if test "$WX_DEBUG_CONFIGURE" = "1"; then - echo "[[dbg]] Values of all WX_* options after final detection:" - echo "[[dbg]] WX_DEBUG: $WX_DEBUG" - echo "[[dbg]] WX_UNICODE: $WX_UNICODE" - echo "[[dbg]] WX_SHARED: $WX_SHARED" - echo "[[dbg]] WX_RELEASE: $WX_RELEASE" - echo "[[dbg]] WX_PORT: $WX_PORT" - fi - - dnl Avoid problem described in the WX_STANDARD_OPTIONS which happens when - dnl the user gives the options: - dnl ./configure --enable-shared --without-wxshared - dnl or just do - dnl ./configure --enable-shared - dnl but there is only a static build of wxWidgets available. - if test "$WX_SHARED" = "0" -a "$SHARED" = "1"; then - AC_MSG_ERROR([ - Cannot build shared library against a static build of wxWidgets ! - This error happens because the wxWidgets build which was selected - has been detected as static while you asked to build $PACKAGE_NAME - as shared library and this is not possible. - Use the '--disable-shared' option to build $PACKAGE_NAME - as static library or '--with-wxshared' to use wxWidgets as shared library. - ]) - fi - - dnl now we can finally update the DEBUG,UNICODE,SHARED options - dnl to their final values if they were set to 'auto' - if test "$DEBUG" = "auto"; then - DEBUG=$WX_DEBUG - fi - if test "$UNICODE" = "auto"; then - UNICODE=$WX_UNICODE - fi - if test "$SHARED" = "auto"; then - SHARED=$WX_SHARED - fi - if test "$TOOLKIT" = "auto"; then - TOOLKIT=$WX_PORT - fi - - dnl in case the user needs a BUILD=debug/release var... - if test "$DEBUG" = "1"; then - BUILD="debug" - elif test "$DEBUG" = "0" -o "$DEBUG" = ""; then - BUILD="release" - fi - - dnl respect the DEBUG variable adding the optimize/debug flags - dnl NOTE: the CXXFLAGS are merged together with the CPPFLAGS so we - dnl don't need to set them, too - if test "$DEBUG" = "1"; then - CXXFLAGS="$CXXFLAGS -g -O0" - CFLAGS="$CFLAGS -g -O0" - else - CXXFLAGS="$CXXFLAGS -O2" - CFLAGS="$CFLAGS -O2" - fi - ]) -m4trace:/usr/share/aclocal/wxwin.m4:986: -1- AC_DEFUN([WX_BOOLOPT_SUMMARY], [ - if test "x$$1" = "x1" ; then - echo $2 - elif test "x$$1" = "x0" ; then - echo $3 - else - echo "$1 is $$1" - fi - ]) -m4trace:/usr/share/aclocal/wxwin.m4:1003: -1- AC_DEFUN([WX_STANDARD_OPTIONS_SUMMARY_MSG], [ - echo - echo " The wxWidgets build which will be used by $PACKAGE_NAME $PACKAGE_VERSION" - echo " has the following settings:" - WX_BOOLOPT_SUMMARY([WX_DEBUG], [" - DEBUG build"], [" - RELEASE build"]) - WX_BOOLOPT_SUMMARY([WX_UNICODE], [" - UNICODE mode"], [" - ANSI mode"]) - WX_BOOLOPT_SUMMARY([WX_SHARED], [" - SHARED mode"], [" - STATIC mode"]) - echo " - VERSION: $WX_VERSION" - echo " - PORT: $WX_PORT" - ]) -m4trace:/usr/share/aclocal/wxwin.m4:1030: -1- AC_DEFUN([WX_STANDARD_OPTIONS_SUMMARY_MSG_BEGIN], [ - echo - echo " ----------------------------------------------------------------" - echo " Configuration for $PACKAGE_NAME $PACKAGE_VERSION successfully completed." - echo " Summary of main configuration settings for $PACKAGE_NAME:" - WX_BOOLOPT_SUMMARY([DEBUG], [" - DEBUG build"], [" - RELEASE build"]) - WX_BOOLOPT_SUMMARY([UNICODE], [" - UNICODE mode"], [" - ANSI mode"]) - WX_BOOLOPT_SUMMARY([SHARED], [" - SHARED mode"], [" - STATIC mode"]) - ]) -m4trace:/usr/share/aclocal/wxwin.m4:1041: -1- AC_DEFUN([WX_STANDARD_OPTIONS_SUMMARY_MSG_END], [ - WX_STANDARD_OPTIONS_SUMMARY_MSG - echo - echo " Now, just run make." - echo " ----------------------------------------------------------------" - echo - ]) -m4trace:/usr/share/aclocal/wxwin.m4:1055: -1- AC_DEFUN([AM_OPTIONS_WXCONFIG], [WX_CONFIG_OPTIONS]) -m4trace:/usr/share/aclocal/wxwin.m4:1056: -1- AC_DEFUN([AM_PATH_WXCONFIG], [ - WX_CONFIG_CHECK([$1],[$2],[$3],[$4],[$5]) -]) -m4trace:/usr/share/aclocal/wxwin.m4:1059: -1- AC_DEFUN([AM_PATH_WXRC], [WXRC_CHECK([$1],[$2])]) -m4trace:/usr/share/aclocal-1.15/amversion.m4:14: -1- AC_DEFUN([AM_AUTOMAKE_VERSION], [am__api_version='1.15' -dnl Some users find AM_AUTOMAKE_VERSION and mistake it for a way to -dnl require some minimum version. Point them to the right macro. -m4_if([$1], [1.15], [], - [AC_FATAL([Do not call $0, use AM_INIT_AUTOMAKE([$1]).])])dnl -]) -m4trace:/usr/share/aclocal-1.15/amversion.m4:33: -1- AC_DEFUN([AM_SET_CURRENT_AUTOMAKE_VERSION], [AM_AUTOMAKE_VERSION([1.15])dnl -m4_ifndef([AC_AUTOCONF_VERSION], - [m4_copy([m4_PACKAGE_VERSION], [AC_AUTOCONF_VERSION])])dnl -_AM_AUTOCONF_VERSION(m4_defn([AC_AUTOCONF_VERSION]))]) -m4trace:/usr/share/aclocal-1.15/auxdir.m4:47: -1- AC_DEFUN([AM_AUX_DIR_EXPAND], [AC_REQUIRE([AC_CONFIG_AUX_DIR_DEFAULT])dnl -# Expand $ac_aux_dir to an absolute path. -am_aux_dir=`cd "$ac_aux_dir" && pwd` -]) -m4trace:/usr/share/aclocal-1.15/cond.m4:12: -1- AC_DEFUN([AM_CONDITIONAL], [AC_PREREQ([2.52])dnl - m4_if([$1], [TRUE], [AC_FATAL([$0: invalid condition: $1])], - [$1], [FALSE], [AC_FATAL([$0: invalid condition: $1])])dnl -AC_SUBST([$1_TRUE])dnl -AC_SUBST([$1_FALSE])dnl -_AM_SUBST_NOTMAKE([$1_TRUE])dnl -_AM_SUBST_NOTMAKE([$1_FALSE])dnl -m4_define([_AM_COND_VALUE_$1], [$2])dnl -if $2; then - $1_TRUE= - $1_FALSE='#' -else - $1_TRUE='#' - $1_FALSE= -fi -AC_CONFIG_COMMANDS_PRE( -[if test -z "${$1_TRUE}" && test -z "${$1_FALSE}"; then - AC_MSG_ERROR([[conditional "$1" was never defined. -Usually this means the macro was only invoked conditionally.]]) -fi])]) -m4trace:/usr/share/aclocal-1.15/depend.m4:26: -1- AC_DEFUN([_AM_DEPENDENCIES], [AC_REQUIRE([AM_SET_DEPDIR])dnl -AC_REQUIRE([AM_OUTPUT_DEPENDENCY_COMMANDS])dnl -AC_REQUIRE([AM_MAKE_INCLUDE])dnl -AC_REQUIRE([AM_DEP_TRACK])dnl - -m4_if([$1], [CC], [depcc="$CC" am_compiler_list=], - [$1], [CXX], [depcc="$CXX" am_compiler_list=], - [$1], [OBJC], [depcc="$OBJC" am_compiler_list='gcc3 gcc'], - [$1], [OBJCXX], [depcc="$OBJCXX" am_compiler_list='gcc3 gcc'], - [$1], [UPC], [depcc="$UPC" am_compiler_list=], - [$1], [GCJ], [depcc="$GCJ" am_compiler_list='gcc3 gcc'], - [depcc="$$1" am_compiler_list=]) - -AC_CACHE_CHECK([dependency style of $depcc], - [am_cv_$1_dependencies_compiler_type], -[if test -z "$AMDEP_TRUE" && test -f "$am_depcomp"; then - # We make a subdir and do the tests there. Otherwise we can end up - # making bogus files that we don't know about and never remove. For - # instance it was reported that on HP-UX the gcc test will end up - # making a dummy file named 'D' -- because '-MD' means "put the output - # in D". - rm -rf conftest.dir - mkdir conftest.dir - # Copy depcomp to subdir because otherwise we won't find it if we're - # using a relative directory. - cp "$am_depcomp" conftest.dir - cd conftest.dir - # We will build objects and dependencies in a subdirectory because - # it helps to detect inapplicable dependency modes. For instance - # both Tru64's cc and ICC support -MD to output dependencies as a - # side effect of compilation, but ICC will put the dependencies in - # the current directory while Tru64 will put them in the object - # directory. - mkdir sub - - am_cv_$1_dependencies_compiler_type=none - if test "$am_compiler_list" = ""; then - am_compiler_list=`sed -n ['s/^#*\([a-zA-Z0-9]*\))$/\1/p'] < ./depcomp` - fi - am__universal=false - m4_case([$1], [CC], - [case " $depcc " in #( - *\ -arch\ *\ -arch\ *) am__universal=true ;; - esac], - [CXX], - [case " $depcc " in #( - *\ -arch\ *\ -arch\ *) am__universal=true ;; - esac]) - - for depmode in $am_compiler_list; do - # Setup a source with many dependencies, because some compilers - # like to wrap large dependency lists on column 80 (with \), and - # we should not choose a depcomp mode which is confused by this. - # - # We need to recreate these files for each test, as the compiler may - # overwrite some of them when testing with obscure command lines. - # This happens at least with the AIX C compiler. - : > sub/conftest.c - for i in 1 2 3 4 5 6; do - echo '#include "conftst'$i'.h"' >> sub/conftest.c - # Using ": > sub/conftst$i.h" creates only sub/conftst1.h with - # Solaris 10 /bin/sh. - echo '/* dummy */' > sub/conftst$i.h - done - echo "${am__include} ${am__quote}sub/conftest.Po${am__quote}" > confmf - - # We check with '-c' and '-o' for the sake of the "dashmstdout" - # mode. It turns out that the SunPro C++ compiler does not properly - # handle '-M -o', and we need to detect this. Also, some Intel - # versions had trouble with output in subdirs. - am__obj=sub/conftest.${OBJEXT-o} - am__minus_obj="-o $am__obj" - case $depmode in - gcc) - # This depmode causes a compiler race in universal mode. - test "$am__universal" = false || continue - ;; - nosideeffect) - # After this tag, mechanisms are not by side-effect, so they'll - # only be used when explicitly requested. - if test "x$enable_dependency_tracking" = xyes; then - continue - else - break - fi - ;; - msvc7 | msvc7msys | msvisualcpp | msvcmsys) - # This compiler won't grok '-c -o', but also, the minuso test has - # not run yet. These depmodes are late enough in the game, and - # so weak that their functioning should not be impacted. - am__obj=conftest.${OBJEXT-o} - am__minus_obj= - ;; - none) break ;; - esac - if depmode=$depmode \ - source=sub/conftest.c object=$am__obj \ - depfile=sub/conftest.Po tmpdepfile=sub/conftest.TPo \ - $SHELL ./depcomp $depcc -c $am__minus_obj sub/conftest.c \ - >/dev/null 2>conftest.err && - grep sub/conftst1.h sub/conftest.Po > /dev/null 2>&1 && - grep sub/conftst6.h sub/conftest.Po > /dev/null 2>&1 && - grep $am__obj sub/conftest.Po > /dev/null 2>&1 && - ${MAKE-make} -s -f confmf > /dev/null 2>&1; then - # icc doesn't choke on unknown options, it will just issue warnings - # or remarks (even with -Werror). So we grep stderr for any message - # that says an option was ignored or not supported. - # When given -MP, icc 7.0 and 7.1 complain thusly: - # icc: Command line warning: ignoring option '-M'; no argument required - # The diagnosis changed in icc 8.0: - # icc: Command line remark: option '-MP' not supported - if (grep 'ignoring option' conftest.err || - grep 'not supported' conftest.err) >/dev/null 2>&1; then :; else - am_cv_$1_dependencies_compiler_type=$depmode - break - fi - fi - done - - cd .. - rm -rf conftest.dir -else - am_cv_$1_dependencies_compiler_type=none -fi -]) -AC_SUBST([$1DEPMODE], [depmode=$am_cv_$1_dependencies_compiler_type]) -AM_CONDITIONAL([am__fastdep$1], [ - test "x$enable_dependency_tracking" != xno \ - && test "$am_cv_$1_dependencies_compiler_type" = gcc3]) -]) -m4trace:/usr/share/aclocal-1.15/depend.m4:163: -1- AC_DEFUN([AM_SET_DEPDIR], [AC_REQUIRE([AM_SET_LEADING_DOT])dnl -AC_SUBST([DEPDIR], ["${am__leading_dot}deps"])dnl -]) -m4trace:/usr/share/aclocal-1.15/depend.m4:171: -1- AC_DEFUN([AM_DEP_TRACK], [AC_ARG_ENABLE([dependency-tracking], [dnl -AS_HELP_STRING( - [--enable-dependency-tracking], - [do not reject slow dependency extractors]) -AS_HELP_STRING( - [--disable-dependency-tracking], - [speeds up one-time build])]) -if test "x$enable_dependency_tracking" != xno; then - am_depcomp="$ac_aux_dir/depcomp" - AMDEPBACKSLASH='\' - am__nodep='_no' -fi -AM_CONDITIONAL([AMDEP], [test "x$enable_dependency_tracking" != xno]) -AC_SUBST([AMDEPBACKSLASH])dnl -_AM_SUBST_NOTMAKE([AMDEPBACKSLASH])dnl -AC_SUBST([am__nodep])dnl -_AM_SUBST_NOTMAKE([am__nodep])dnl -]) -m4trace:/usr/share/aclocal-1.15/depout.m4:12: -1- AC_DEFUN([_AM_OUTPUT_DEPENDENCY_COMMANDS], [{ - # Older Autoconf quotes --file arguments for eval, but not when files - # are listed without --file. Let's play safe and only enable the eval - # if we detect the quoting. - case $CONFIG_FILES in - *\'*) eval set x "$CONFIG_FILES" ;; - *) set x $CONFIG_FILES ;; - esac - shift - for mf - do - # Strip MF so we end up with the name of the file. - mf=`echo "$mf" | sed -e 's/:.*$//'` - # Check whether this is an Automake generated Makefile or not. - # We used to match only the files named 'Makefile.in', but - # some people rename them; so instead we look at the file content. - # Grep'ing the first line is not enough: some people post-process - # each Makefile.in and add a new line on top of each file to say so. - # Grep'ing the whole file is not good either: AIX grep has a line - # limit of 2048, but all sed's we know have understand at least 4000. - if sed -n 's,^#.*generated by automake.*,X,p' "$mf" | grep X >/dev/null 2>&1; then - dirpart=`AS_DIRNAME("$mf")` - else - continue - fi - # Extract the definition of DEPDIR, am__include, and am__quote - # from the Makefile without running 'make'. - DEPDIR=`sed -n 's/^DEPDIR = //p' < "$mf"` - test -z "$DEPDIR" && continue - am__include=`sed -n 's/^am__include = //p' < "$mf"` - test -z "$am__include" && continue - am__quote=`sed -n 's/^am__quote = //p' < "$mf"` - # Find all dependency output files, they are included files with - # $(DEPDIR) in their names. We invoke sed twice because it is the - # simplest approach to changing $(DEPDIR) to its actual value in the - # expansion. - for file in `sed -n " - s/^$am__include $am__quote\(.*(DEPDIR).*\)$am__quote"'$/\1/p' <"$mf" | \ - sed -e 's/\$(DEPDIR)/'"$DEPDIR"'/g'`; do - # Make sure the directory exists. - test -f "$dirpart/$file" && continue - fdir=`AS_DIRNAME(["$file"])` - AS_MKDIR_P([$dirpart/$fdir]) - # echo "creating $dirpart/$file" - echo '# dummy' > "$dirpart/$file" - done - done -} -]) -m4trace:/usr/share/aclocal-1.15/depout.m4:71: -1- AC_DEFUN([AM_OUTPUT_DEPENDENCY_COMMANDS], [AC_CONFIG_COMMANDS([depfiles], - [test x"$AMDEP_TRUE" != x"" || _AM_OUTPUT_DEPENDENCY_COMMANDS], - [AMDEP_TRUE="$AMDEP_TRUE" ac_aux_dir="$ac_aux_dir"]) -]) -m4trace:/usr/share/aclocal-1.15/init.m4:29: -1- AC_DEFUN([AM_INIT_AUTOMAKE], [AC_PREREQ([2.65])dnl -dnl Autoconf wants to disallow AM_ names. We explicitly allow -dnl the ones we care about. -m4_pattern_allow([^AM_[A-Z]+FLAGS$])dnl -AC_REQUIRE([AM_SET_CURRENT_AUTOMAKE_VERSION])dnl -AC_REQUIRE([AC_PROG_INSTALL])dnl -if test "`cd $srcdir && pwd`" != "`pwd`"; then - # Use -I$(srcdir) only when $(srcdir) != ., so that make's output - # is not polluted with repeated "-I." - AC_SUBST([am__isrc], [' -I$(srcdir)'])_AM_SUBST_NOTMAKE([am__isrc])dnl - # test to see if srcdir already configured - if test -f $srcdir/config.status; then - AC_MSG_ERROR([source directory already configured; run "make distclean" there first]) - fi -fi - -# test whether we have cygpath -if test -z "$CYGPATH_W"; then - if (cygpath --version) >/dev/null 2>/dev/null; then - CYGPATH_W='cygpath -w' - else - CYGPATH_W=echo - fi -fi -AC_SUBST([CYGPATH_W]) - -# Define the identity of the package. -dnl Distinguish between old-style and new-style calls. -m4_ifval([$2], -[AC_DIAGNOSE([obsolete], - [$0: two- and three-arguments forms are deprecated.]) -m4_ifval([$3], [_AM_SET_OPTION([no-define])])dnl - AC_SUBST([PACKAGE], [$1])dnl - AC_SUBST([VERSION], [$2])], -[_AM_SET_OPTIONS([$1])dnl -dnl Diagnose old-style AC_INIT with new-style AM_AUTOMAKE_INIT. -m4_if( - m4_ifdef([AC_PACKAGE_NAME], [ok]):m4_ifdef([AC_PACKAGE_VERSION], [ok]), - [ok:ok],, - [m4_fatal([AC_INIT should be called with package and version arguments])])dnl - AC_SUBST([PACKAGE], ['AC_PACKAGE_TARNAME'])dnl - AC_SUBST([VERSION], ['AC_PACKAGE_VERSION'])])dnl - -_AM_IF_OPTION([no-define],, -[AC_DEFINE_UNQUOTED([PACKAGE], ["$PACKAGE"], [Name of package]) - AC_DEFINE_UNQUOTED([VERSION], ["$VERSION"], [Version number of package])])dnl - -# Some tools Automake needs. -AC_REQUIRE([AM_SANITY_CHECK])dnl -AC_REQUIRE([AC_ARG_PROGRAM])dnl -AM_MISSING_PROG([ACLOCAL], [aclocal-${am__api_version}]) -AM_MISSING_PROG([AUTOCONF], [autoconf]) -AM_MISSING_PROG([AUTOMAKE], [automake-${am__api_version}]) -AM_MISSING_PROG([AUTOHEADER], [autoheader]) -AM_MISSING_PROG([MAKEINFO], [makeinfo]) -AC_REQUIRE([AM_PROG_INSTALL_SH])dnl -AC_REQUIRE([AM_PROG_INSTALL_STRIP])dnl -AC_REQUIRE([AC_PROG_MKDIR_P])dnl -# For better backward compatibility. To be removed once Automake 1.9.x -# dies out for good. For more background, see: -# -# -AC_SUBST([mkdir_p], ['$(MKDIR_P)']) -# We need awk for the "check" target (and possibly the TAP driver). The -# system "awk" is bad on some platforms. -AC_REQUIRE([AC_PROG_AWK])dnl -AC_REQUIRE([AC_PROG_MAKE_SET])dnl -AC_REQUIRE([AM_SET_LEADING_DOT])dnl -_AM_IF_OPTION([tar-ustar], [_AM_PROG_TAR([ustar])], - [_AM_IF_OPTION([tar-pax], [_AM_PROG_TAR([pax])], - [_AM_PROG_TAR([v7])])]) -_AM_IF_OPTION([no-dependencies],, -[AC_PROVIDE_IFELSE([AC_PROG_CC], - [_AM_DEPENDENCIES([CC])], - [m4_define([AC_PROG_CC], - m4_defn([AC_PROG_CC])[_AM_DEPENDENCIES([CC])])])dnl -AC_PROVIDE_IFELSE([AC_PROG_CXX], - [_AM_DEPENDENCIES([CXX])], - [m4_define([AC_PROG_CXX], - m4_defn([AC_PROG_CXX])[_AM_DEPENDENCIES([CXX])])])dnl -AC_PROVIDE_IFELSE([AC_PROG_OBJC], - [_AM_DEPENDENCIES([OBJC])], - [m4_define([AC_PROG_OBJC], - m4_defn([AC_PROG_OBJC])[_AM_DEPENDENCIES([OBJC])])])dnl -AC_PROVIDE_IFELSE([AC_PROG_OBJCXX], - [_AM_DEPENDENCIES([OBJCXX])], - [m4_define([AC_PROG_OBJCXX], - m4_defn([AC_PROG_OBJCXX])[_AM_DEPENDENCIES([OBJCXX])])])dnl -]) -AC_REQUIRE([AM_SILENT_RULES])dnl -dnl The testsuite driver may need to know about EXEEXT, so add the -dnl 'am__EXEEXT' conditional if _AM_COMPILER_EXEEXT was seen. This -dnl macro is hooked onto _AC_COMPILER_EXEEXT early, see below. -AC_CONFIG_COMMANDS_PRE(dnl -[m4_provide_if([_AM_COMPILER_EXEEXT], - [AM_CONDITIONAL([am__EXEEXT], [test -n "$EXEEXT"])])])dnl - -# POSIX will say in a future version that running "rm -f" with no argument -# is OK; and we want to be able to make that assumption in our Makefile -# recipes. So use an aggressive probe to check that the usage we want is -# actually supported "in the wild" to an acceptable degree. -# See automake bug#10828. -# To make any issue more visible, cause the running configure to be aborted -# by default if the 'rm' program in use doesn't match our expectations; the -# user can still override this though. -if rm -f && rm -fr && rm -rf; then : OK; else - cat >&2 <<'END' -Oops! - -Your 'rm' program seems unable to run without file operands specified -on the command line, even when the '-f' option is present. This is contrary -to the behaviour of most rm programs out there, and not conforming with -the upcoming POSIX standard: - -Please tell bug-automake@gnu.org about your system, including the value -of your $PATH and any error possibly output before this message. This -can help us improve future automake versions. - -END - if test x"$ACCEPT_INFERIOR_RM_PROGRAM" = x"yes"; then - echo 'Configuration will proceed anyway, since you have set the' >&2 - echo 'ACCEPT_INFERIOR_RM_PROGRAM variable to "yes"' >&2 - echo >&2 - else - cat >&2 <<'END' -Aborting the configuration process, to ensure you take notice of the issue. - -You can download and install GNU coreutils to get an 'rm' implementation -that behaves properly: . - -If you want to complete the configuration process using your problematic -'rm' anyway, export the environment variable ACCEPT_INFERIOR_RM_PROGRAM -to "yes", and re-run configure. - -END - AC_MSG_ERROR([Your 'rm' program is bad, sorry.]) - fi -fi -dnl The trailing newline in this macro's definition is deliberate, for -dnl backward compatibility and to allow trailing 'dnl'-style comments -dnl after the AM_INIT_AUTOMAKE invocation. See automake bug#16841. -]) -m4trace:/usr/share/aclocal-1.15/init.m4:186: -1- AC_DEFUN([_AC_AM_CONFIG_HEADER_HOOK], [# Compute $1's index in $config_headers. -_am_arg=$1 -_am_stamp_count=1 -for _am_header in $config_headers :; do - case $_am_header in - $_am_arg | $_am_arg:* ) - break ;; - * ) - _am_stamp_count=`expr $_am_stamp_count + 1` ;; - esac -done -echo "timestamp for $_am_arg" >`AS_DIRNAME(["$_am_arg"])`/stamp-h[]$_am_stamp_count]) -m4trace:/usr/share/aclocal-1.15/install-sh.m4:11: -1- AC_DEFUN([AM_PROG_INSTALL_SH], [AC_REQUIRE([AM_AUX_DIR_EXPAND])dnl -if test x"${install_sh+set}" != xset; then - case $am_aux_dir in - *\ * | *\ *) - install_sh="\${SHELL} '$am_aux_dir/install-sh'" ;; - *) - install_sh="\${SHELL} $am_aux_dir/install-sh" - esac -fi -AC_SUBST([install_sh])]) -m4trace:/usr/share/aclocal-1.15/lead-dot.m4:10: -1- AC_DEFUN([AM_SET_LEADING_DOT], [rm -rf .tst 2>/dev/null -mkdir .tst 2>/dev/null -if test -d .tst; then - am__leading_dot=. -else - am__leading_dot=_ -fi -rmdir .tst 2>/dev/null -AC_SUBST([am__leading_dot])]) -m4trace:/usr/share/aclocal-1.15/make.m4:12: -1- AC_DEFUN([AM_MAKE_INCLUDE], [am_make=${MAKE-make} -cat > confinc << 'END' -am__doit: - @echo this is the am__doit target -.PHONY: am__doit -END -# If we don't find an include directive, just comment out the code. -AC_MSG_CHECKING([for style of include used by $am_make]) -am__include="#" -am__quote= -_am_result=none -# First try GNU make style include. -echo "include confinc" > confmf -# Ignore all kinds of additional output from 'make'. -case `$am_make -s -f confmf 2> /dev/null` in #( -*the\ am__doit\ target*) - am__include=include - am__quote= - _am_result=GNU - ;; -esac -# Now try BSD make style include. -if test "$am__include" = "#"; then - echo '.include "confinc"' > confmf - case `$am_make -s -f confmf 2> /dev/null` in #( - *the\ am__doit\ target*) - am__include=.include - am__quote="\"" - _am_result=BSD - ;; - esac -fi -AC_SUBST([am__include]) -AC_SUBST([am__quote]) -AC_MSG_RESULT([$_am_result]) -rm -f confinc confmf -]) -m4trace:/usr/share/aclocal-1.15/missing.m4:11: -1- AC_DEFUN([AM_MISSING_PROG], [AC_REQUIRE([AM_MISSING_HAS_RUN]) -$1=${$1-"${am_missing_run}$2"} -AC_SUBST($1)]) -m4trace:/usr/share/aclocal-1.15/missing.m4:20: -1- AC_DEFUN([AM_MISSING_HAS_RUN], [AC_REQUIRE([AM_AUX_DIR_EXPAND])dnl -AC_REQUIRE_AUX_FILE([missing])dnl -if test x"${MISSING+set}" != xset; then - case $am_aux_dir in - *\ * | *\ *) - MISSING="\${SHELL} \"$am_aux_dir/missing\"" ;; - *) - MISSING="\${SHELL} $am_aux_dir/missing" ;; - esac -fi -# Use eval to expand $SHELL -if eval "$MISSING --is-lightweight"; then - am_missing_run="$MISSING " -else - am_missing_run= - AC_MSG_WARN(['missing' script is too old or missing]) -fi -]) -m4trace:/usr/share/aclocal-1.15/options.m4:11: -1- AC_DEFUN([_AM_MANGLE_OPTION], [[_AM_OPTION_]m4_bpatsubst($1, [[^a-zA-Z0-9_]], [_])]) -m4trace:/usr/share/aclocal-1.15/options.m4:17: -1- AC_DEFUN([_AM_SET_OPTION], [m4_define(_AM_MANGLE_OPTION([$1]), [1])]) -m4trace:/usr/share/aclocal-1.15/options.m4:23: -1- AC_DEFUN([_AM_SET_OPTIONS], [m4_foreach_w([_AM_Option], [$1], [_AM_SET_OPTION(_AM_Option)])]) -m4trace:/usr/share/aclocal-1.15/options.m4:29: -1- AC_DEFUN([_AM_IF_OPTION], [m4_ifset(_AM_MANGLE_OPTION([$1]), [$2], [$3])]) -m4trace:/usr/share/aclocal-1.15/prog-cc-c-o.m4:12: -1- AC_DEFUN([_AM_PROG_CC_C_O], [AC_REQUIRE([AM_AUX_DIR_EXPAND])dnl -AC_REQUIRE_AUX_FILE([compile])dnl -AC_LANG_PUSH([C])dnl -AC_CACHE_CHECK( - [whether $CC understands -c and -o together], - [am_cv_prog_cc_c_o], - [AC_LANG_CONFTEST([AC_LANG_PROGRAM([])]) - # Make sure it works both with $CC and with simple cc. - # Following AC_PROG_CC_C_O, we do the test twice because some - # compilers refuse to overwrite an existing .o file with -o, - # though they will create one. - am_cv_prog_cc_c_o=yes - for am_i in 1 2; do - if AM_RUN_LOG([$CC -c conftest.$ac_ext -o conftest2.$ac_objext]) \ - && test -f conftest2.$ac_objext; then - : OK - else - am_cv_prog_cc_c_o=no - break - fi - done - rm -f core conftest* - unset am_i]) -if test "$am_cv_prog_cc_c_o" != yes; then - # Losing compiler, so override with the script. - # FIXME: It is wrong to rewrite CC. - # But if we don't then we get into trouble of one sort or another. - # A longer-term fix would be to have automake use am__CC in this case, - # and then we could set am__CC="\$(top_srcdir)/compile \$(CC)" - CC="$am_aux_dir/compile $CC" -fi -AC_LANG_POP([C])]) -m4trace:/usr/share/aclocal-1.15/prog-cc-c-o.m4:47: -1- AC_DEFUN_ONCE([AM_PROG_CC_C_O], [AC_REQUIRE([AC_PROG_CC])]) -m4trace:/usr/share/aclocal-1.15/runlog.m4:12: -1- AC_DEFUN([AM_RUN_LOG], [{ echo "$as_me:$LINENO: $1" >&AS_MESSAGE_LOG_FD - ($1) >&AS_MESSAGE_LOG_FD 2>&AS_MESSAGE_LOG_FD - ac_status=$? - echo "$as_me:$LINENO: \$? = $ac_status" >&AS_MESSAGE_LOG_FD - (exit $ac_status); }]) -m4trace:/usr/share/aclocal-1.15/sanity.m4:11: -1- AC_DEFUN([AM_SANITY_CHECK], [AC_MSG_CHECKING([whether build environment is sane]) -# Reject unsafe characters in $srcdir or the absolute working directory -# name. Accept space and tab only in the latter. -am_lf=' -' -case `pwd` in - *[[\\\"\#\$\&\'\`$am_lf]]*) - AC_MSG_ERROR([unsafe absolute working directory name]);; -esac -case $srcdir in - *[[\\\"\#\$\&\'\`$am_lf\ \ ]]*) - AC_MSG_ERROR([unsafe srcdir value: '$srcdir']);; -esac - -# Do 'set' in a subshell so we don't clobber the current shell's -# arguments. Must try -L first in case configure is actually a -# symlink; some systems play weird games with the mod time of symlinks -# (eg FreeBSD returns the mod time of the symlink's containing -# directory). -if ( - am_has_slept=no - for am_try in 1 2; do - echo "timestamp, slept: $am_has_slept" > conftest.file - set X `ls -Lt "$srcdir/configure" conftest.file 2> /dev/null` - if test "$[*]" = "X"; then - # -L didn't work. - set X `ls -t "$srcdir/configure" conftest.file` - fi - if test "$[*]" != "X $srcdir/configure conftest.file" \ - && test "$[*]" != "X conftest.file $srcdir/configure"; then - - # If neither matched, then we have a broken ls. This can happen - # if, for instance, CONFIG_SHELL is bash and it inherits a - # broken ls alias from the environment. This has actually - # happened. Such a system could not be considered "sane". - AC_MSG_ERROR([ls -t appears to fail. Make sure there is not a broken - alias in your environment]) - fi - if test "$[2]" = conftest.file || test $am_try -eq 2; then - break - fi - # Just in case. - sleep 1 - am_has_slept=yes - done - test "$[2]" = conftest.file - ) -then - # Ok. - : -else - AC_MSG_ERROR([newly created file is older than distributed files! -Check your system clock]) -fi -AC_MSG_RESULT([yes]) -# If we didn't sleep, we still need to ensure time stamps of config.status and -# generated files are strictly newer. -am_sleep_pid= -if grep 'slept: no' conftest.file >/dev/null 2>&1; then - ( sleep 1 ) & - am_sleep_pid=$! -fi -AC_CONFIG_COMMANDS_PRE( - [AC_MSG_CHECKING([that generated files are newer than configure]) - if test -n "$am_sleep_pid"; then - # Hide warnings about reused PIDs. - wait $am_sleep_pid 2>/dev/null - fi - AC_MSG_RESULT([done])]) -rm -f conftest.file -]) -m4trace:/usr/share/aclocal-1.15/silent.m4:12: -1- AC_DEFUN([AM_SILENT_RULES], [AC_ARG_ENABLE([silent-rules], [dnl -AS_HELP_STRING( - [--enable-silent-rules], - [less verbose build output (undo: "make V=1")]) -AS_HELP_STRING( - [--disable-silent-rules], - [verbose build output (undo: "make V=0")])dnl -]) -case $enable_silent_rules in @%:@ ((( - yes) AM_DEFAULT_VERBOSITY=0;; - no) AM_DEFAULT_VERBOSITY=1;; - *) AM_DEFAULT_VERBOSITY=m4_if([$1], [yes], [0], [1]);; -esac -dnl -dnl A few 'make' implementations (e.g., NonStop OS and NextStep) -dnl do not support nested variable expansions. -dnl See automake bug#9928 and bug#10237. -am_make=${MAKE-make} -AC_CACHE_CHECK([whether $am_make supports nested variables], - [am_cv_make_support_nested_variables], - [if AS_ECHO([['TRUE=$(BAR$(V)) -BAR0=false -BAR1=true -V=1 -am__doit: - @$(TRUE) -.PHONY: am__doit']]) | $am_make -f - >/dev/null 2>&1; then - am_cv_make_support_nested_variables=yes -else - am_cv_make_support_nested_variables=no -fi]) -if test $am_cv_make_support_nested_variables = yes; then - dnl Using '$V' instead of '$(V)' breaks IRIX make. - AM_V='$(V)' - AM_DEFAULT_V='$(AM_DEFAULT_VERBOSITY)' -else - AM_V=$AM_DEFAULT_VERBOSITY - AM_DEFAULT_V=$AM_DEFAULT_VERBOSITY -fi -AC_SUBST([AM_V])dnl -AM_SUBST_NOTMAKE([AM_V])dnl -AC_SUBST([AM_DEFAULT_V])dnl -AM_SUBST_NOTMAKE([AM_DEFAULT_V])dnl -AC_SUBST([AM_DEFAULT_VERBOSITY])dnl -AM_BACKSLASH='\' -AC_SUBST([AM_BACKSLASH])dnl -_AM_SUBST_NOTMAKE([AM_BACKSLASH])dnl -]) -m4trace:/usr/share/aclocal-1.15/strip.m4:17: -1- AC_DEFUN([AM_PROG_INSTALL_STRIP], [AC_REQUIRE([AM_PROG_INSTALL_SH])dnl -# Installed binaries are usually stripped using 'strip' when the user -# run "make install-strip". However 'strip' might not be the right -# tool to use in cross-compilation environments, therefore Automake -# will honor the 'STRIP' environment variable to overrule this program. -dnl Don't test for $cross_compiling = yes, because it might be 'maybe'. -if test "$cross_compiling" != no; then - AC_CHECK_TOOL([STRIP], [strip], :) -fi -INSTALL_STRIP_PROGRAM="\$(install_sh) -c -s" -AC_SUBST([INSTALL_STRIP_PROGRAM])]) -m4trace:/usr/share/aclocal-1.15/substnot.m4:12: -1- AC_DEFUN([_AM_SUBST_NOTMAKE]) -m4trace:/usr/share/aclocal-1.15/substnot.m4:17: -1- AC_DEFUN([AM_SUBST_NOTMAKE], [_AM_SUBST_NOTMAKE($@)]) -m4trace:/usr/share/aclocal-1.15/tar.m4:23: -1- AC_DEFUN([_AM_PROG_TAR], [# Always define AMTAR for backward compatibility. Yes, it's still used -# in the wild :-( We should find a proper way to deprecate it ... -AC_SUBST([AMTAR], ['$${TAR-tar}']) - -# We'll loop over all known methods to create a tar archive until one works. -_am_tools='gnutar m4_if([$1], [ustar], [plaintar]) pax cpio none' - -m4_if([$1], [v7], - [am__tar='$${TAR-tar} chof - "$$tardir"' am__untar='$${TAR-tar} xf -'], - - [m4_case([$1], - [ustar], - [# The POSIX 1988 'ustar' format is defined with fixed-size fields. - # There is notably a 21 bits limit for the UID and the GID. In fact, - # the 'pax' utility can hang on bigger UID/GID (see automake bug#8343 - # and bug#13588). - am_max_uid=2097151 # 2^21 - 1 - am_max_gid=$am_max_uid - # The $UID and $GID variables are not portable, so we need to resort - # to the POSIX-mandated id(1) utility. Errors in the 'id' calls - # below are definitely unexpected, so allow the users to see them - # (that is, avoid stderr redirection). - am_uid=`id -u || echo unknown` - am_gid=`id -g || echo unknown` - AC_MSG_CHECKING([whether UID '$am_uid' is supported by ustar format]) - if test $am_uid -le $am_max_uid; then - AC_MSG_RESULT([yes]) - else - AC_MSG_RESULT([no]) - _am_tools=none - fi - AC_MSG_CHECKING([whether GID '$am_gid' is supported by ustar format]) - if test $am_gid -le $am_max_gid; then - AC_MSG_RESULT([yes]) - else - AC_MSG_RESULT([no]) - _am_tools=none - fi], - - [pax], - [], - - [m4_fatal([Unknown tar format])]) - - AC_MSG_CHECKING([how to create a $1 tar archive]) - - # Go ahead even if we have the value already cached. We do so because we - # need to set the values for the 'am__tar' and 'am__untar' variables. - _am_tools=${am_cv_prog_tar_$1-$_am_tools} - - for _am_tool in $_am_tools; do - case $_am_tool in - gnutar) - for _am_tar in tar gnutar gtar; do - AM_RUN_LOG([$_am_tar --version]) && break - done - am__tar="$_am_tar --format=m4_if([$1], [pax], [posix], [$1]) -chf - "'"$$tardir"' - am__tar_="$_am_tar --format=m4_if([$1], [pax], [posix], [$1]) -chf - "'"$tardir"' - am__untar="$_am_tar -xf -" - ;; - plaintar) - # Must skip GNU tar: if it does not support --format= it doesn't create - # ustar tarball either. - (tar --version) >/dev/null 2>&1 && continue - am__tar='tar chf - "$$tardir"' - am__tar_='tar chf - "$tardir"' - am__untar='tar xf -' - ;; - pax) - am__tar='pax -L -x $1 -w "$$tardir"' - am__tar_='pax -L -x $1 -w "$tardir"' - am__untar='pax -r' - ;; - cpio) - am__tar='find "$$tardir" -print | cpio -o -H $1 -L' - am__tar_='find "$tardir" -print | cpio -o -H $1 -L' - am__untar='cpio -i -H $1 -d' - ;; - none) - am__tar=false - am__tar_=false - am__untar=false - ;; - esac - - # If the value was cached, stop now. We just wanted to have am__tar - # and am__untar set. - test -n "${am_cv_prog_tar_$1}" && break - - # tar/untar a dummy directory, and stop if the command works. - rm -rf conftest.dir - mkdir conftest.dir - echo GrepMe > conftest.dir/file - AM_RUN_LOG([tardir=conftest.dir && eval $am__tar_ >conftest.tar]) - rm -rf conftest.dir - if test -s conftest.tar; then - AM_RUN_LOG([$am__untar /dev/null 2>&1 && break - fi - done - rm -rf conftest.dir - - AC_CACHE_VAL([am_cv_prog_tar_$1], [am_cv_prog_tar_$1=$_am_tool]) - AC_MSG_RESULT([$am_cv_prog_tar_$1])]) - -AC_SUBST([am__tar]) -AC_SUBST([am__untar]) -]) -m4trace:configure.ac:21: -1- m4_pattern_forbid([^_?A[CHUM]_]) -m4trace:configure.ac:21: -1- m4_pattern_forbid([_AC_]) -m4trace:configure.ac:21: -1- m4_pattern_forbid([^LIBOBJS$], [do not use LIBOBJS directly, use AC_LIBOBJ (see section `AC_LIBOBJ vs LIBOBJS']) -m4trace:configure.ac:21: -1- m4_pattern_allow([^AS_FLAGS$]) -m4trace:configure.ac:21: -1- m4_pattern_forbid([^_?m4_]) -m4trace:configure.ac:21: -1- m4_pattern_forbid([^dnl$]) -m4trace:configure.ac:21: -1- m4_pattern_forbid([^_?AS_]) -m4trace:configure.ac:21: -1- m4_pattern_allow([^SHELL$]) -m4trace:configure.ac:21: -1- m4_pattern_allow([^PATH_SEPARATOR$]) -m4trace:configure.ac:21: -1- m4_pattern_allow([^PACKAGE_NAME$]) -m4trace:configure.ac:21: -1- m4_pattern_allow([^PACKAGE_TARNAME$]) -m4trace:configure.ac:21: -1- m4_pattern_allow([^PACKAGE_VERSION$]) -m4trace:configure.ac:21: -1- m4_pattern_allow([^PACKAGE_STRING$]) -m4trace:configure.ac:21: -1- m4_pattern_allow([^PACKAGE_BUGREPORT$]) -m4trace:configure.ac:21: -1- m4_pattern_allow([^PACKAGE_URL$]) -m4trace:configure.ac:21: -1- m4_pattern_allow([^exec_prefix$]) -m4trace:configure.ac:21: -1- m4_pattern_allow([^prefix$]) -m4trace:configure.ac:21: -1- m4_pattern_allow([^program_transform_name$]) -m4trace:configure.ac:21: -1- m4_pattern_allow([^bindir$]) -m4trace:configure.ac:21: -1- m4_pattern_allow([^sbindir$]) -m4trace:configure.ac:21: -1- m4_pattern_allow([^libexecdir$]) -m4trace:configure.ac:21: -1- m4_pattern_allow([^datarootdir$]) -m4trace:configure.ac:21: -1- m4_pattern_allow([^datadir$]) -m4trace:configure.ac:21: -1- m4_pattern_allow([^sysconfdir$]) -m4trace:configure.ac:21: -1- m4_pattern_allow([^sharedstatedir$]) -m4trace:configure.ac:21: -1- m4_pattern_allow([^localstatedir$]) -m4trace:configure.ac:21: -1- m4_pattern_allow([^runstatedir$]) -m4trace:configure.ac:21: -1- m4_pattern_allow([^includedir$]) -m4trace:configure.ac:21: -1- m4_pattern_allow([^oldincludedir$]) -m4trace:configure.ac:21: -1- m4_pattern_allow([^docdir$]) -m4trace:configure.ac:21: -1- m4_pattern_allow([^infodir$]) -m4trace:configure.ac:21: -1- m4_pattern_allow([^htmldir$]) -m4trace:configure.ac:21: -1- m4_pattern_allow([^dvidir$]) -m4trace:configure.ac:21: -1- m4_pattern_allow([^pdfdir$]) -m4trace:configure.ac:21: -1- m4_pattern_allow([^psdir$]) -m4trace:configure.ac:21: -1- m4_pattern_allow([^libdir$]) -m4trace:configure.ac:21: -1- m4_pattern_allow([^localedir$]) -m4trace:configure.ac:21: -1- m4_pattern_allow([^mandir$]) -m4trace:configure.ac:21: -1- m4_pattern_allow([^PACKAGE_NAME$]) -m4trace:configure.ac:21: -1- m4_pattern_allow([^PACKAGE_TARNAME$]) -m4trace:configure.ac:21: -1- m4_pattern_allow([^PACKAGE_VERSION$]) -m4trace:configure.ac:21: -1- m4_pattern_allow([^PACKAGE_STRING$]) -m4trace:configure.ac:21: -1- m4_pattern_allow([^PACKAGE_BUGREPORT$]) -m4trace:configure.ac:21: -1- m4_pattern_allow([^PACKAGE_URL$]) -m4trace:configure.ac:21: -1- m4_pattern_allow([^DEFS$]) -m4trace:configure.ac:21: -1- m4_pattern_allow([^ECHO_C$]) -m4trace:configure.ac:21: -1- m4_pattern_allow([^ECHO_N$]) -m4trace:configure.ac:21: -1- m4_pattern_allow([^ECHO_T$]) -m4trace:configure.ac:21: -1- m4_pattern_allow([^LIBS$]) -m4trace:configure.ac:21: -1- m4_pattern_allow([^build_alias$]) -m4trace:configure.ac:21: -1- m4_pattern_allow([^host_alias$]) -m4trace:configure.ac:21: -1- m4_pattern_allow([^target_alias$]) -m4trace:configure.ac:25: -1- m4_pattern_allow([^develop$]) -m4trace:configure.ac:27: -1- m4_pattern_allow([^DEVELBUILD$]) -m4trace:configure.ac:28: -1- m4_pattern_allow([^DATEBUILD$]) -m4trace:configure.ac:32: -1- m4_pattern_allow([^build$]) -m4trace:configure.ac:32: -1- m4_pattern_allow([^build_cpu$]) -m4trace:configure.ac:32: -1- m4_pattern_allow([^build_vendor$]) -m4trace:configure.ac:32: -1- m4_pattern_allow([^build_os$]) -m4trace:configure.ac:34: -1- AM_INIT_AUTOMAKE -m4trace:configure.ac:34: -1- m4_pattern_allow([^AM_[A-Z]+FLAGS$]) -m4trace:configure.ac:34: -1- AM_SET_CURRENT_AUTOMAKE_VERSION -m4trace:configure.ac:34: -1- AM_AUTOMAKE_VERSION([1.15]) -m4trace:configure.ac:34: -1- _AM_AUTOCONF_VERSION([2.69]) -m4trace:configure.ac:34: -1- m4_pattern_allow([^INSTALL_PROGRAM$]) -m4trace:configure.ac:34: -1- m4_pattern_allow([^INSTALL_SCRIPT$]) -m4trace:configure.ac:34: -1- m4_pattern_allow([^INSTALL_DATA$]) -m4trace:configure.ac:34: -1- m4_pattern_allow([^am__isrc$]) -m4trace:configure.ac:34: -1- _AM_SUBST_NOTMAKE([am__isrc]) -m4trace:configure.ac:34: -1- m4_pattern_allow([^CYGPATH_W$]) -m4trace:configure.ac:34: -1- _AM_SET_OPTIONS([]) -m4trace:configure.ac:34: -1- m4_pattern_allow([^PACKAGE$]) -m4trace:configure.ac:34: -1- m4_pattern_allow([^VERSION$]) -m4trace:configure.ac:34: -1- _AM_IF_OPTION([no-define], [], [AC_DEFINE_UNQUOTED([PACKAGE], ["$PACKAGE"], [Name of package]) - AC_DEFINE_UNQUOTED([VERSION], ["$VERSION"], [Version number of package])]) -m4trace:configure.ac:34: -2- _AM_MANGLE_OPTION([no-define]) -m4trace:configure.ac:34: -1- m4_pattern_allow([^PACKAGE$]) -m4trace:configure.ac:34: -1- m4_pattern_allow([^VERSION$]) -m4trace:configure.ac:34: -1- AM_SANITY_CHECK -m4trace:configure.ac:34: -1- AM_MISSING_PROG([ACLOCAL], [aclocal-${am__api_version}]) -m4trace:configure.ac:34: -1- AM_MISSING_HAS_RUN -m4trace:configure.ac:34: -1- AM_AUX_DIR_EXPAND -m4trace:configure.ac:34: -1- m4_pattern_allow([^ACLOCAL$]) -m4trace:configure.ac:34: -1- AM_MISSING_PROG([AUTOCONF], [autoconf]) -m4trace:configure.ac:34: -1- m4_pattern_allow([^AUTOCONF$]) -m4trace:configure.ac:34: -1- AM_MISSING_PROG([AUTOMAKE], [automake-${am__api_version}]) -m4trace:configure.ac:34: -1- m4_pattern_allow([^AUTOMAKE$]) -m4trace:configure.ac:34: -1- AM_MISSING_PROG([AUTOHEADER], [autoheader]) -m4trace:configure.ac:34: -1- m4_pattern_allow([^AUTOHEADER$]) -m4trace:configure.ac:34: -1- AM_MISSING_PROG([MAKEINFO], [makeinfo]) -m4trace:configure.ac:34: -1- m4_pattern_allow([^MAKEINFO$]) -m4trace:configure.ac:34: -1- AM_PROG_INSTALL_SH -m4trace:configure.ac:34: -1- m4_pattern_allow([^install_sh$]) -m4trace:configure.ac:34: -1- AM_PROG_INSTALL_STRIP -m4trace:configure.ac:34: -1- m4_pattern_allow([^STRIP$]) -m4trace:configure.ac:34: -1- m4_pattern_allow([^INSTALL_STRIP_PROGRAM$]) -m4trace:configure.ac:34: -1- m4_pattern_allow([^MKDIR_P$]) -m4trace:configure.ac:34: -1- m4_pattern_allow([^mkdir_p$]) -m4trace:configure.ac:34: -1- m4_pattern_allow([^AWK$]) -m4trace:configure.ac:34: -1- m4_pattern_allow([^SET_MAKE$]) -m4trace:configure.ac:34: -1- AM_SET_LEADING_DOT -m4trace:configure.ac:34: -1- m4_pattern_allow([^am__leading_dot$]) -m4trace:configure.ac:34: -1- _AM_IF_OPTION([tar-ustar], [_AM_PROG_TAR([ustar])], [_AM_IF_OPTION([tar-pax], [_AM_PROG_TAR([pax])], - [_AM_PROG_TAR([v7])])]) -m4trace:configure.ac:34: -2- _AM_MANGLE_OPTION([tar-ustar]) -m4trace:configure.ac:34: -1- _AM_IF_OPTION([tar-pax], [_AM_PROG_TAR([pax])], [_AM_PROG_TAR([v7])]) -m4trace:configure.ac:34: -2- _AM_MANGLE_OPTION([tar-pax]) -m4trace:configure.ac:34: -1- _AM_PROG_TAR([v7]) -m4trace:configure.ac:34: -1- m4_pattern_allow([^AMTAR$]) -m4trace:configure.ac:34: -1- m4_pattern_allow([^am__tar$]) -m4trace:configure.ac:34: -1- m4_pattern_allow([^am__untar$]) -m4trace:configure.ac:34: -1- _AM_IF_OPTION([no-dependencies], [], [AC_PROVIDE_IFELSE([AC_PROG_CC], - [_AM_DEPENDENCIES([CC])], - [m4_define([AC_PROG_CC], - m4_defn([AC_PROG_CC])[_AM_DEPENDENCIES([CC])])])dnl -AC_PROVIDE_IFELSE([AC_PROG_CXX], - [_AM_DEPENDENCIES([CXX])], - [m4_define([AC_PROG_CXX], - m4_defn([AC_PROG_CXX])[_AM_DEPENDENCIES([CXX])])])dnl -AC_PROVIDE_IFELSE([AC_PROG_OBJC], - [_AM_DEPENDENCIES([OBJC])], - [m4_define([AC_PROG_OBJC], - m4_defn([AC_PROG_OBJC])[_AM_DEPENDENCIES([OBJC])])])dnl -AC_PROVIDE_IFELSE([AC_PROG_OBJCXX], - [_AM_DEPENDENCIES([OBJCXX])], - [m4_define([AC_PROG_OBJCXX], - m4_defn([AC_PROG_OBJCXX])[_AM_DEPENDENCIES([OBJCXX])])])dnl -]) -m4trace:configure.ac:34: -2- _AM_MANGLE_OPTION([no-dependencies]) -m4trace:configure.ac:34: -1- AM_SILENT_RULES -m4trace:configure.ac:34: -1- m4_pattern_allow([^AM_V$]) -m4trace:configure.ac:34: -1- AM_SUBST_NOTMAKE([AM_V]) -m4trace:configure.ac:34: -1- _AM_SUBST_NOTMAKE([AM_V]) -m4trace:configure.ac:34: -1- m4_pattern_allow([^AM_DEFAULT_V$]) -m4trace:configure.ac:34: -1- AM_SUBST_NOTMAKE([AM_DEFAULT_V]) -m4trace:configure.ac:34: -1- _AM_SUBST_NOTMAKE([AM_DEFAULT_V]) -m4trace:configure.ac:34: -1- m4_pattern_allow([^AM_DEFAULT_VERBOSITY$]) -m4trace:configure.ac:34: -1- m4_pattern_allow([^AM_BACKSLASH$]) -m4trace:configure.ac:34: -1- _AM_SUBST_NOTMAKE([AM_BACKSLASH]) -m4trace:configure.ac:36: -1- m4_pattern_allow([^CC$]) -m4trace:configure.ac:36: -1- m4_pattern_allow([^CFLAGS$]) -m4trace:configure.ac:36: -1- m4_pattern_allow([^LDFLAGS$]) -m4trace:configure.ac:36: -1- m4_pattern_allow([^LIBS$]) -m4trace:configure.ac:36: -1- m4_pattern_allow([^CPPFLAGS$]) -m4trace:configure.ac:36: -1- m4_pattern_allow([^CC$]) -m4trace:configure.ac:36: -1- m4_pattern_allow([^CC$]) -m4trace:configure.ac:36: -1- m4_pattern_allow([^CC$]) -m4trace:configure.ac:36: -1- m4_pattern_allow([^CC$]) -m4trace:configure.ac:36: -1- m4_pattern_allow([^ac_ct_CC$]) -m4trace:configure.ac:36: -1- m4_pattern_allow([^EXEEXT$]) -m4trace:configure.ac:36: -1- m4_pattern_allow([^OBJEXT$]) -m4trace:configure.ac:36: -1- _AM_PROG_CC_C_O -m4trace:configure.ac:36: -1- AM_RUN_LOG([$CC -c conftest.$ac_ext -o conftest2.$ac_objext]) -m4trace:configure.ac:36: -1- _AM_DEPENDENCIES([CC]) -m4trace:configure.ac:36: -1- AM_SET_DEPDIR -m4trace:configure.ac:36: -1- m4_pattern_allow([^DEPDIR$]) -m4trace:configure.ac:36: -1- AM_OUTPUT_DEPENDENCY_COMMANDS -m4trace:configure.ac:36: -1- AM_MAKE_INCLUDE -m4trace:configure.ac:36: -1- m4_pattern_allow([^am__include$]) -m4trace:configure.ac:36: -1- m4_pattern_allow([^am__quote$]) -m4trace:configure.ac:36: -1- AM_DEP_TRACK -m4trace:configure.ac:36: -1- AM_CONDITIONAL([AMDEP], [test "x$enable_dependency_tracking" != xno]) -m4trace:configure.ac:36: -1- m4_pattern_allow([^AMDEP_TRUE$]) -m4trace:configure.ac:36: -1- m4_pattern_allow([^AMDEP_FALSE$]) -m4trace:configure.ac:36: -1- _AM_SUBST_NOTMAKE([AMDEP_TRUE]) -m4trace:configure.ac:36: -1- _AM_SUBST_NOTMAKE([AMDEP_FALSE]) -m4trace:configure.ac:36: -1- m4_pattern_allow([^AMDEPBACKSLASH$]) -m4trace:configure.ac:36: -1- _AM_SUBST_NOTMAKE([AMDEPBACKSLASH]) -m4trace:configure.ac:36: -1- m4_pattern_allow([^am__nodep$]) -m4trace:configure.ac:36: -1- _AM_SUBST_NOTMAKE([am__nodep]) -m4trace:configure.ac:36: -1- m4_pattern_allow([^CCDEPMODE$]) -m4trace:configure.ac:36: -1- AM_CONDITIONAL([am__fastdepCC], [ - test "x$enable_dependency_tracking" != xno \ - && test "$am_cv_CC_dependencies_compiler_type" = gcc3]) -m4trace:configure.ac:36: -1- m4_pattern_allow([^am__fastdepCC_TRUE$]) -m4trace:configure.ac:36: -1- m4_pattern_allow([^am__fastdepCC_FALSE$]) -m4trace:configure.ac:36: -1- _AM_SUBST_NOTMAKE([am__fastdepCC_TRUE]) -m4trace:configure.ac:36: -1- _AM_SUBST_NOTMAKE([am__fastdepCC_FALSE]) -m4trace:configure.ac:37: -1- m4_pattern_allow([^CXX$]) -m4trace:configure.ac:37: -1- m4_pattern_allow([^CXXFLAGS$]) -m4trace:configure.ac:37: -1- m4_pattern_allow([^LDFLAGS$]) -m4trace:configure.ac:37: -1- m4_pattern_allow([^LIBS$]) -m4trace:configure.ac:37: -1- m4_pattern_allow([^CPPFLAGS$]) -m4trace:configure.ac:37: -1- m4_pattern_allow([^CXX$]) -m4trace:configure.ac:37: -1- m4_pattern_allow([^ac_ct_CXX$]) -m4trace:configure.ac:37: -1- _AM_DEPENDENCIES([CXX]) -m4trace:configure.ac:37: -1- m4_pattern_allow([^CXXDEPMODE$]) -m4trace:configure.ac:37: -1- AM_CONDITIONAL([am__fastdepCXX], [ - test "x$enable_dependency_tracking" != xno \ - && test "$am_cv_CXX_dependencies_compiler_type" = gcc3]) -m4trace:configure.ac:37: -1- m4_pattern_allow([^am__fastdepCXX_TRUE$]) -m4trace:configure.ac:37: -1- m4_pattern_allow([^am__fastdepCXX_FALSE$]) -m4trace:configure.ac:37: -1- _AM_SUBST_NOTMAKE([am__fastdepCXX_TRUE]) -m4trace:configure.ac:37: -1- _AM_SUBST_NOTMAKE([am__fastdepCXX_FALSE]) -m4trace:configure.ac:38: -1- m4_pattern_allow([^CPP$]) -m4trace:configure.ac:38: -1- m4_pattern_allow([^CPPFLAGS$]) -m4trace:configure.ac:38: -1- m4_pattern_allow([^CPP$]) -m4trace:configure.ac:39: -1- m4_pattern_allow([^FC$]) -m4trace:configure.ac:39: -1- m4_pattern_allow([^FCFLAGS$]) -m4trace:configure.ac:39: -1- m4_pattern_allow([^LDFLAGS$]) -m4trace:configure.ac:39: -1- m4_pattern_allow([^LIBS$]) -m4trace:configure.ac:39: -1- m4_pattern_allow([^FC$]) -m4trace:configure.ac:39: -1- m4_pattern_allow([^ac_ct_FC$]) -m4trace:configure.ac:40: -1- m4_pattern_allow([^RANLIB$]) -m4trace:configure.ac:42: -1- m4_pattern_allow([^LN_S$]) -m4trace:configure.ac:43: -1- m4_pattern_allow([^SET_MAKE$]) -m4trace:configure.ac:45: -1- m4_pattern_allow([^GREP$]) -m4trace:configure.ac:45: -1- m4_pattern_allow([^EGREP$]) -m4trace:configure.ac:45: -1- m4_pattern_allow([^STDC_HEADERS$]) -m4trace:configure.ac:47: -1- m4_pattern_allow([^size_t$]) -m4trace:configure.ac:48: -1- m4_pattern_allow([^TM_IN_SYS_TIME$]) -m4trace:configure.ac:49: -1- m4_pattern_allow([^const$]) -m4trace:configure.ac:50: -1- m4_pattern_allow([^HAVE_STDLIB_H$]) -m4trace:configure.ac:50: -1- m4_pattern_allow([^HAVE_MALLOC$]) -m4trace:configure.ac:50: -1- m4_pattern_allow([^HAVE_MALLOC$]) -m4trace:configure.ac:50: -1- m4_pattern_allow([^LIB@&t@OBJS$]) -m4trace:configure.ac:50: -1- m4_pattern_allow([^malloc$]) -m4trace:configure.ac:52: -1- m4_pattern_allow([^FC_MODINC$]) -m4trace:configure.ac:52: -1- m4_pattern_allow([^ac_empty$]) -m4trace:configure.ac:53: -1- m4_pattern_allow([^FC_MODOUT$]) -m4trace:configure.ac:53: -1- m4_pattern_allow([^ac_empty$]) -m4trace:configure.ac:54: -1- m4_pattern_allow([^FC_MODEXT$]) -m4trace:configure.ac:72: -1- m4_pattern_allow([^HAVE_FITSIO_H$]) -m4trace:configure.ac:73: -2- m4_pattern_allow([^LIBCFITSIO$]) -m4trace:configure.ac:78: -1- m4_pattern_allow([^HAVE_LIBMINPACK$]) -m4trace:configure.ac:78: -1- m4_pattern_allow([^F77$]) -m4trace:configure.ac:78: -1- m4_pattern_allow([^FFLAGS$]) -m4trace:configure.ac:78: -1- m4_pattern_allow([^LDFLAGS$]) -m4trace:configure.ac:78: -1- m4_pattern_allow([^LIBS$]) -m4trace:configure.ac:78: -1- m4_pattern_allow([^F77$]) -m4trace:configure.ac:78: -1- m4_pattern_allow([^ac_ct_F77$]) -m4trace:configure.ac:78: -1- m4_pattern_allow([^MINPACKDIR$]) -m4trace:configure.ac:78: -1- m4_pattern_allow([^LDMINPACK$]) -m4trace:configure.ac:84: -2- _m4_warn([obsolete], [The macro `AC_HELP_STRING' is obsolete. -You should run autoupdate.], [../../lib/autoconf/general.m4:207: AC_HELP_STRING is expanded from... -configure.ac:84: the top level]) -m4trace:configure.ac:85: -2- _m4_warn([obsolete], [The macro `AC_HELP_STRING' is obsolete. -You should run autoupdate.], [../../lib/autoconf/general.m4:207: AC_HELP_STRING is expanded from... -configure.ac:85: the top level]) -m4trace:configure.ac:86: -2- _m4_warn([obsolete], [The macro `AC_HELP_STRING' is obsolete. -You should run autoupdate.], [../../lib/autoconf/general.m4:207: AC_HELP_STRING is expanded from... -configure.ac:86: the top level]) -m4trace:configure.ac:91: -1- AM_OPTIONS_WXCONFIG -m4trace:configure.ac:91: -1- WX_CONFIG_OPTIONS -m4trace:configure.ac:92: -1- AM_PATH_WXCONFIG([3.0.0], [wxWin=1]) -m4trace:configure.ac:92: -1- WX_CONFIG_CHECK([3.0.0], [wxWin=1], [], [], []) -m4trace:configure.ac:92: -1- m4_pattern_allow([^WX_CONFIG_PATH$]) -m4trace:configure.ac:92: -1- _WX_PRIVATE_CHECK_VERSION([$wx_requested_major_version], [$wx_requested_minor_version], [$wx_requested_micro_version]) -m4trace:configure.ac:92: -1- m4_pattern_allow([^WX_CPPFLAGS$]) -m4trace:configure.ac:92: -1- m4_pattern_allow([^WX_CFLAGS$]) -m4trace:configure.ac:92: -1- m4_pattern_allow([^WX_CXXFLAGS$]) -m4trace:configure.ac:92: -1- m4_pattern_allow([^WX_CFLAGS_ONLY$]) -m4trace:configure.ac:92: -1- m4_pattern_allow([^WX_CXXFLAGS_ONLY$]) -m4trace:configure.ac:92: -1- m4_pattern_allow([^WX_LIBS$]) -m4trace:configure.ac:92: -1- m4_pattern_allow([^WX_LIBS_STATIC$]) -m4trace:configure.ac:92: -1- m4_pattern_allow([^WX_VERSION$]) -m4trace:configure.ac:92: -1- m4_pattern_allow([^WX_RESCOMP$]) -m4trace:configure.ac:92: -1- m4_pattern_allow([^WX_VERSION_MAJOR$]) -m4trace:configure.ac:92: -1- m4_pattern_allow([^WX_VERSION_MINOR$]) -m4trace:configure.ac:92: -1- m4_pattern_allow([^WX_VERSION_MICRO$]) -m4trace:configure.ac:129: -1- m4_pattern_allow([^XMUNIPACKDIR$]) -m4trace:configure.ac:130: -1- m4_pattern_allow([^MATPLOTDIR$]) -m4trace:configure.ac:135: -1- m4_pattern_allow([^MUNIPACKDIR$]) -m4trace:configure.ac:136: -1- m4_pattern_allow([^WX_CXXFLAGS_CLI$]) -m4trace:configure.ac:137: -1- m4_pattern_allow([^WX_LIBS_CLI$]) -m4trace:configure.ac:142: -1- m4_pattern_allow([^WX_LIBS_VO$]) -m4trace:configure.ac:143: -1- m4_pattern_allow([^WX_CXXFLAGS_VO$]) -m4trace:configure.ac:144: -1- m4_pattern_allow([^VODIR$]) -m4trace:configure.ac:149: -2- _m4_warn([obsolete], [The macro `AC_HELP_STRING' is obsolete. -You should run autoupdate.], [../../lib/autoconf/general.m4:207: AC_HELP_STRING is expanded from... -configure.ac:149: the top level]) -m4trace:configure.ac:150: -1- AM_CONDITIONAL([BUNDLE], [test "x$enable_bundle" = "xyes"]) -m4trace:configure.ac:150: -1- m4_pattern_allow([^BUNDLE_TRUE$]) -m4trace:configure.ac:150: -1- m4_pattern_allow([^BUNDLE_FALSE$]) -m4trace:configure.ac:150: -1- _AM_SUBST_NOTMAKE([BUNDLE_TRUE]) -m4trace:configure.ac:150: -1- _AM_SUBST_NOTMAKE([BUNDLE_FALSE]) -m4trace:configure.ac:153: -1- m4_pattern_allow([^BUNDLEDIR$]) -m4trace:configure.ac:160: -1- m4_pattern_allow([^LIBGFORTRAN$]) -m4trace:configure.ac:161: -1- m4_pattern_allow([^LIBGCC$]) -m4trace:configure.ac:162: -1- m4_pattern_allow([^LIBSTDCPP$]) -m4trace:configure.ac:166: -1- m4_pattern_allow([^CLEANFILES$]) -m4trace:configure.ac:177: -1- m4_pattern_allow([^LIB@&t@OBJS$]) -m4trace:configure.ac:177: -1- m4_pattern_allow([^LTLIBOBJS$]) -m4trace:configure.ac:177: -1- AM_CONDITIONAL([am__EXEEXT], [test -n "$EXEEXT"]) -m4trace:configure.ac:177: -1- m4_pattern_allow([^am__EXEEXT_TRUE$]) -m4trace:configure.ac:177: -1- m4_pattern_allow([^am__EXEEXT_FALSE$]) -m4trace:configure.ac:177: -1- _AM_SUBST_NOTMAKE([am__EXEEXT_TRUE]) -m4trace:configure.ac:177: -1- _AM_SUBST_NOTMAKE([am__EXEEXT_FALSE]) -m4trace:configure.ac:177: -1- _AC_AM_CONFIG_HEADER_HOOK(["$ac_file"]) -m4trace:configure.ac:177: -1- _AM_OUTPUT_DEPENDENCY_COMMANDS diff -Nru munipack-0.5.9/autom4te.cache/traces.1 munipack-0.5.10/autom4te.cache/traces.1 --- munipack-0.5.9/autom4te.cache/traces.1 2017-07-17 23:04:25.000000000 +0000 +++ munipack-0.5.10/autom4te.cache/traces.1 1970-01-01 00:00:00.000000000 +0000 @@ -1,665 +0,0 @@ -m4trace:configure.ac:21: -1- AC_INIT([Munipack], [m4_esyscmd(echo -n $VERSION)], [Filip Hroch ], [munipack], [http://munipack.physics.muni.cz]) -m4trace:configure.ac:21: -1- m4_pattern_forbid([^_?A[CHUM]_]) -m4trace:configure.ac:21: -1- m4_pattern_forbid([_AC_]) -m4trace:configure.ac:21: -1- m4_pattern_forbid([^LIBOBJS$], [do not use LIBOBJS directly, use AC_LIBOBJ (see section `AC_LIBOBJ vs LIBOBJS']) -m4trace:configure.ac:21: -1- m4_pattern_allow([^AS_FLAGS$]) -m4trace:configure.ac:21: -1- m4_pattern_forbid([^_?m4_]) -m4trace:configure.ac:21: -1- m4_pattern_forbid([^dnl$]) -m4trace:configure.ac:21: -1- m4_pattern_forbid([^_?AS_]) -m4trace:configure.ac:21: -1- AC_SUBST([SHELL]) -m4trace:configure.ac:21: -1- AC_SUBST_TRACE([SHELL]) -m4trace:configure.ac:21: -1- m4_pattern_allow([^SHELL$]) -m4trace:configure.ac:21: -1- AC_SUBST([PATH_SEPARATOR]) -m4trace:configure.ac:21: -1- AC_SUBST_TRACE([PATH_SEPARATOR]) -m4trace:configure.ac:21: -1- m4_pattern_allow([^PATH_SEPARATOR$]) -m4trace:configure.ac:21: -1- AC_SUBST([PACKAGE_NAME], [m4_ifdef([AC_PACKAGE_NAME], ['AC_PACKAGE_NAME'])]) -m4trace:configure.ac:21: -1- AC_SUBST_TRACE([PACKAGE_NAME]) -m4trace:configure.ac:21: -1- m4_pattern_allow([^PACKAGE_NAME$]) -m4trace:configure.ac:21: -1- AC_SUBST([PACKAGE_TARNAME], [m4_ifdef([AC_PACKAGE_TARNAME], ['AC_PACKAGE_TARNAME'])]) -m4trace:configure.ac:21: -1- AC_SUBST_TRACE([PACKAGE_TARNAME]) -m4trace:configure.ac:21: -1- m4_pattern_allow([^PACKAGE_TARNAME$]) -m4trace:configure.ac:21: -1- AC_SUBST([PACKAGE_VERSION], [m4_ifdef([AC_PACKAGE_VERSION], ['AC_PACKAGE_VERSION'])]) -m4trace:configure.ac:21: -1- AC_SUBST_TRACE([PACKAGE_VERSION]) -m4trace:configure.ac:21: -1- m4_pattern_allow([^PACKAGE_VERSION$]) -m4trace:configure.ac:21: -1- AC_SUBST([PACKAGE_STRING], [m4_ifdef([AC_PACKAGE_STRING], ['AC_PACKAGE_STRING'])]) -m4trace:configure.ac:21: -1- AC_SUBST_TRACE([PACKAGE_STRING]) -m4trace:configure.ac:21: -1- m4_pattern_allow([^PACKAGE_STRING$]) -m4trace:configure.ac:21: -1- AC_SUBST([PACKAGE_BUGREPORT], [m4_ifdef([AC_PACKAGE_BUGREPORT], ['AC_PACKAGE_BUGREPORT'])]) -m4trace:configure.ac:21: -1- AC_SUBST_TRACE([PACKAGE_BUGREPORT]) -m4trace:configure.ac:21: -1- m4_pattern_allow([^PACKAGE_BUGREPORT$]) -m4trace:configure.ac:21: -1- AC_SUBST([PACKAGE_URL], [m4_ifdef([AC_PACKAGE_URL], ['AC_PACKAGE_URL'])]) -m4trace:configure.ac:21: -1- AC_SUBST_TRACE([PACKAGE_URL]) -m4trace:configure.ac:21: -1- m4_pattern_allow([^PACKAGE_URL$]) -m4trace:configure.ac:21: -1- AC_SUBST([exec_prefix], [NONE]) -m4trace:configure.ac:21: -1- AC_SUBST_TRACE([exec_prefix]) -m4trace:configure.ac:21: -1- m4_pattern_allow([^exec_prefix$]) -m4trace:configure.ac:21: -1- AC_SUBST([prefix], [NONE]) -m4trace:configure.ac:21: -1- AC_SUBST_TRACE([prefix]) -m4trace:configure.ac:21: -1- m4_pattern_allow([^prefix$]) -m4trace:configure.ac:21: -1- AC_SUBST([program_transform_name], [s,x,x,]) -m4trace:configure.ac:21: -1- AC_SUBST_TRACE([program_transform_name]) -m4trace:configure.ac:21: -1- m4_pattern_allow([^program_transform_name$]) -m4trace:configure.ac:21: -1- AC_SUBST([bindir], ['${exec_prefix}/bin']) -m4trace:configure.ac:21: -1- AC_SUBST_TRACE([bindir]) -m4trace:configure.ac:21: -1- m4_pattern_allow([^bindir$]) -m4trace:configure.ac:21: -1- AC_SUBST([sbindir], ['${exec_prefix}/sbin']) -m4trace:configure.ac:21: -1- AC_SUBST_TRACE([sbindir]) -m4trace:configure.ac:21: -1- m4_pattern_allow([^sbindir$]) -m4trace:configure.ac:21: -1- AC_SUBST([libexecdir], ['${exec_prefix}/libexec']) -m4trace:configure.ac:21: -1- AC_SUBST_TRACE([libexecdir]) -m4trace:configure.ac:21: -1- m4_pattern_allow([^libexecdir$]) -m4trace:configure.ac:21: -1- AC_SUBST([datarootdir], ['${prefix}/share']) -m4trace:configure.ac:21: -1- AC_SUBST_TRACE([datarootdir]) -m4trace:configure.ac:21: -1- m4_pattern_allow([^datarootdir$]) -m4trace:configure.ac:21: -1- AC_SUBST([datadir], ['${datarootdir}']) -m4trace:configure.ac:21: -1- AC_SUBST_TRACE([datadir]) -m4trace:configure.ac:21: -1- m4_pattern_allow([^datadir$]) -m4trace:configure.ac:21: -1- AC_SUBST([sysconfdir], ['${prefix}/etc']) -m4trace:configure.ac:21: -1- AC_SUBST_TRACE([sysconfdir]) -m4trace:configure.ac:21: -1- m4_pattern_allow([^sysconfdir$]) -m4trace:configure.ac:21: -1- AC_SUBST([sharedstatedir], ['${prefix}/com']) -m4trace:configure.ac:21: -1- AC_SUBST_TRACE([sharedstatedir]) -m4trace:configure.ac:21: -1- m4_pattern_allow([^sharedstatedir$]) -m4trace:configure.ac:21: -1- AC_SUBST([localstatedir], ['${prefix}/var']) -m4trace:configure.ac:21: -1- AC_SUBST_TRACE([localstatedir]) -m4trace:configure.ac:21: -1- m4_pattern_allow([^localstatedir$]) -m4trace:configure.ac:21: -1- AC_SUBST([runstatedir], ['${localstatedir}/run']) -m4trace:configure.ac:21: -1- AC_SUBST_TRACE([runstatedir]) -m4trace:configure.ac:21: -1- m4_pattern_allow([^runstatedir$]) -m4trace:configure.ac:21: -1- AC_SUBST([includedir], ['${prefix}/include']) -m4trace:configure.ac:21: -1- AC_SUBST_TRACE([includedir]) -m4trace:configure.ac:21: -1- m4_pattern_allow([^includedir$]) -m4trace:configure.ac:21: -1- AC_SUBST([oldincludedir], ['/usr/include']) -m4trace:configure.ac:21: -1- AC_SUBST_TRACE([oldincludedir]) -m4trace:configure.ac:21: -1- m4_pattern_allow([^oldincludedir$]) -m4trace:configure.ac:21: -1- AC_SUBST([docdir], [m4_ifset([AC_PACKAGE_TARNAME], - ['${datarootdir}/doc/${PACKAGE_TARNAME}'], - ['${datarootdir}/doc/${PACKAGE}'])]) -m4trace:configure.ac:21: -1- AC_SUBST_TRACE([docdir]) -m4trace:configure.ac:21: -1- m4_pattern_allow([^docdir$]) -m4trace:configure.ac:21: -1- AC_SUBST([infodir], ['${datarootdir}/info']) -m4trace:configure.ac:21: -1- AC_SUBST_TRACE([infodir]) -m4trace:configure.ac:21: -1- m4_pattern_allow([^infodir$]) -m4trace:configure.ac:21: -1- AC_SUBST([htmldir], ['${docdir}']) -m4trace:configure.ac:21: -1- AC_SUBST_TRACE([htmldir]) -m4trace:configure.ac:21: -1- m4_pattern_allow([^htmldir$]) -m4trace:configure.ac:21: -1- AC_SUBST([dvidir], ['${docdir}']) -m4trace:configure.ac:21: -1- AC_SUBST_TRACE([dvidir]) -m4trace:configure.ac:21: -1- m4_pattern_allow([^dvidir$]) -m4trace:configure.ac:21: -1- AC_SUBST([pdfdir], ['${docdir}']) -m4trace:configure.ac:21: -1- AC_SUBST_TRACE([pdfdir]) -m4trace:configure.ac:21: -1- m4_pattern_allow([^pdfdir$]) -m4trace:configure.ac:21: -1- AC_SUBST([psdir], ['${docdir}']) -m4trace:configure.ac:21: -1- AC_SUBST_TRACE([psdir]) -m4trace:configure.ac:21: -1- m4_pattern_allow([^psdir$]) -m4trace:configure.ac:21: -1- AC_SUBST([libdir], ['${exec_prefix}/lib']) -m4trace:configure.ac:21: -1- AC_SUBST_TRACE([libdir]) -m4trace:configure.ac:21: -1- m4_pattern_allow([^libdir$]) -m4trace:configure.ac:21: -1- AC_SUBST([localedir], ['${datarootdir}/locale']) -m4trace:configure.ac:21: -1- AC_SUBST_TRACE([localedir]) -m4trace:configure.ac:21: -1- m4_pattern_allow([^localedir$]) -m4trace:configure.ac:21: -1- AC_SUBST([mandir], ['${datarootdir}/man']) -m4trace:configure.ac:21: -1- AC_SUBST_TRACE([mandir]) -m4trace:configure.ac:21: -1- m4_pattern_allow([^mandir$]) -m4trace:configure.ac:21: -1- AC_DEFINE_TRACE_LITERAL([PACKAGE_NAME]) -m4trace:configure.ac:21: -1- m4_pattern_allow([^PACKAGE_NAME$]) -m4trace:configure.ac:21: -1- AH_OUTPUT([PACKAGE_NAME], [/* Define to the full name of this package. */ -@%:@undef PACKAGE_NAME]) -m4trace:configure.ac:21: -1- AC_DEFINE_TRACE_LITERAL([PACKAGE_TARNAME]) -m4trace:configure.ac:21: -1- m4_pattern_allow([^PACKAGE_TARNAME$]) -m4trace:configure.ac:21: -1- AH_OUTPUT([PACKAGE_TARNAME], [/* Define to the one symbol short name of this package. */ -@%:@undef PACKAGE_TARNAME]) -m4trace:configure.ac:21: -1- AC_DEFINE_TRACE_LITERAL([PACKAGE_VERSION]) -m4trace:configure.ac:21: -1- m4_pattern_allow([^PACKAGE_VERSION$]) -m4trace:configure.ac:21: -1- AH_OUTPUT([PACKAGE_VERSION], [/* Define to the version of this package. */ -@%:@undef PACKAGE_VERSION]) -m4trace:configure.ac:21: -1- AC_DEFINE_TRACE_LITERAL([PACKAGE_STRING]) -m4trace:configure.ac:21: -1- m4_pattern_allow([^PACKAGE_STRING$]) -m4trace:configure.ac:21: -1- AH_OUTPUT([PACKAGE_STRING], [/* Define to the full name and version of this package. */ -@%:@undef PACKAGE_STRING]) -m4trace:configure.ac:21: -1- AC_DEFINE_TRACE_LITERAL([PACKAGE_BUGREPORT]) -m4trace:configure.ac:21: -1- m4_pattern_allow([^PACKAGE_BUGREPORT$]) -m4trace:configure.ac:21: -1- AH_OUTPUT([PACKAGE_BUGREPORT], [/* Define to the address where bug reports for this package should be sent. */ -@%:@undef PACKAGE_BUGREPORT]) -m4trace:configure.ac:21: -1- AC_DEFINE_TRACE_LITERAL([PACKAGE_URL]) -m4trace:configure.ac:21: -1- m4_pattern_allow([^PACKAGE_URL$]) -m4trace:configure.ac:21: -1- AH_OUTPUT([PACKAGE_URL], [/* Define to the home page for this package. */ -@%:@undef PACKAGE_URL]) -m4trace:configure.ac:21: -1- AC_SUBST([DEFS]) -m4trace:configure.ac:21: -1- AC_SUBST_TRACE([DEFS]) -m4trace:configure.ac:21: -1- m4_pattern_allow([^DEFS$]) -m4trace:configure.ac:21: -1- AC_SUBST([ECHO_C]) -m4trace:configure.ac:21: -1- AC_SUBST_TRACE([ECHO_C]) -m4trace:configure.ac:21: -1- m4_pattern_allow([^ECHO_C$]) -m4trace:configure.ac:21: -1- AC_SUBST([ECHO_N]) -m4trace:configure.ac:21: -1- AC_SUBST_TRACE([ECHO_N]) -m4trace:configure.ac:21: -1- m4_pattern_allow([^ECHO_N$]) -m4trace:configure.ac:21: -1- AC_SUBST([ECHO_T]) -m4trace:configure.ac:21: -1- AC_SUBST_TRACE([ECHO_T]) -m4trace:configure.ac:21: -1- m4_pattern_allow([^ECHO_T$]) -m4trace:configure.ac:21: -1- AC_SUBST([LIBS]) -m4trace:configure.ac:21: -1- AC_SUBST_TRACE([LIBS]) -m4trace:configure.ac:21: -1- m4_pattern_allow([^LIBS$]) -m4trace:configure.ac:21: -1- AC_SUBST([build_alias]) -m4trace:configure.ac:21: -1- AC_SUBST_TRACE([build_alias]) -m4trace:configure.ac:21: -1- m4_pattern_allow([^build_alias$]) -m4trace:configure.ac:21: -1- AC_SUBST([host_alias]) -m4trace:configure.ac:21: -1- AC_SUBST_TRACE([host_alias]) -m4trace:configure.ac:21: -1- m4_pattern_allow([^host_alias$]) -m4trace:configure.ac:21: -1- AC_SUBST([target_alias]) -m4trace:configure.ac:21: -1- AC_SUBST_TRACE([target_alias]) -m4trace:configure.ac:21: -1- m4_pattern_allow([^target_alias$]) -m4trace:configure.ac:25: -1- AC_SUBST([develop], [m4_esyscmd(echo -n $DEVELOPMENT)]) -m4trace:configure.ac:25: -1- AC_SUBST_TRACE([develop]) -m4trace:configure.ac:25: -1- m4_pattern_allow([^develop$]) -m4trace:configure.ac:27: -1- AC_DEFINE_TRACE_LITERAL([DEVELBUILD]) -m4trace:configure.ac:27: -1- m4_pattern_allow([^DEVELBUILD$]) -m4trace:configure.ac:27: -1- AH_OUTPUT([DEVELBUILD], [/* indicates development build */ -@%:@undef DEVELBUILD]) -m4trace:configure.ac:28: -1- AC_DEFINE_TRACE_LITERAL([DATEBUILD]) -m4trace:configure.ac:28: -1- m4_pattern_allow([^DATEBUILD$]) -m4trace:configure.ac:28: -1- AH_OUTPUT([DATEBUILD], [/* configure time */ -@%:@undef DATEBUILD]) -m4trace:configure.ac:32: -1- AC_CANONICAL_BUILD -m4trace:configure.ac:32: -1- AC_REQUIRE_AUX_FILE([config.sub]) -m4trace:configure.ac:32: -1- AC_REQUIRE_AUX_FILE([config.guess]) -m4trace:configure.ac:32: -1- AC_SUBST([build], [$ac_cv_build]) -m4trace:configure.ac:32: -1- AC_SUBST_TRACE([build]) -m4trace:configure.ac:32: -1- m4_pattern_allow([^build$]) -m4trace:configure.ac:32: -1- AC_SUBST([build_cpu], [$[1]]) -m4trace:configure.ac:32: -1- AC_SUBST_TRACE([build_cpu]) -m4trace:configure.ac:32: -1- m4_pattern_allow([^build_cpu$]) -m4trace:configure.ac:32: -1- AC_SUBST([build_vendor], [$[2]]) -m4trace:configure.ac:32: -1- AC_SUBST_TRACE([build_vendor]) -m4trace:configure.ac:32: -1- m4_pattern_allow([^build_vendor$]) -m4trace:configure.ac:32: -1- AC_SUBST([build_os]) -m4trace:configure.ac:32: -1- AC_SUBST_TRACE([build_os]) -m4trace:configure.ac:32: -1- m4_pattern_allow([^build_os$]) -m4trace:configure.ac:34: -1- AM_INIT_AUTOMAKE -m4trace:configure.ac:34: -1- m4_pattern_allow([^AM_[A-Z]+FLAGS$]) -m4trace:configure.ac:34: -1- AM_AUTOMAKE_VERSION([1.15]) -m4trace:configure.ac:34: -1- AC_REQUIRE_AUX_FILE([install-sh]) -m4trace:configure.ac:34: -1- AC_SUBST([INSTALL_PROGRAM]) -m4trace:configure.ac:34: -1- AC_SUBST_TRACE([INSTALL_PROGRAM]) -m4trace:configure.ac:34: -1- m4_pattern_allow([^INSTALL_PROGRAM$]) -m4trace:configure.ac:34: -1- AC_SUBST([INSTALL_SCRIPT]) -m4trace:configure.ac:34: -1- AC_SUBST_TRACE([INSTALL_SCRIPT]) -m4trace:configure.ac:34: -1- m4_pattern_allow([^INSTALL_SCRIPT$]) -m4trace:configure.ac:34: -1- AC_SUBST([INSTALL_DATA]) -m4trace:configure.ac:34: -1- AC_SUBST_TRACE([INSTALL_DATA]) -m4trace:configure.ac:34: -1- m4_pattern_allow([^INSTALL_DATA$]) -m4trace:configure.ac:34: -1- AC_SUBST([am__isrc], [' -I$(srcdir)']) -m4trace:configure.ac:34: -1- AC_SUBST_TRACE([am__isrc]) -m4trace:configure.ac:34: -1- m4_pattern_allow([^am__isrc$]) -m4trace:configure.ac:34: -1- _AM_SUBST_NOTMAKE([am__isrc]) -m4trace:configure.ac:34: -1- AC_SUBST([CYGPATH_W]) -m4trace:configure.ac:34: -1- AC_SUBST_TRACE([CYGPATH_W]) -m4trace:configure.ac:34: -1- m4_pattern_allow([^CYGPATH_W$]) -m4trace:configure.ac:34: -1- AC_SUBST([PACKAGE], ['AC_PACKAGE_TARNAME']) -m4trace:configure.ac:34: -1- AC_SUBST_TRACE([PACKAGE]) -m4trace:configure.ac:34: -1- m4_pattern_allow([^PACKAGE$]) -m4trace:configure.ac:34: -1- AC_SUBST([VERSION], ['AC_PACKAGE_VERSION']) -m4trace:configure.ac:34: -1- AC_SUBST_TRACE([VERSION]) -m4trace:configure.ac:34: -1- m4_pattern_allow([^VERSION$]) -m4trace:configure.ac:34: -1- AC_DEFINE_TRACE_LITERAL([PACKAGE]) -m4trace:configure.ac:34: -1- m4_pattern_allow([^PACKAGE$]) -m4trace:configure.ac:34: -1- AH_OUTPUT([PACKAGE], [/* Name of package */ -@%:@undef PACKAGE]) -m4trace:configure.ac:34: -1- AC_DEFINE_TRACE_LITERAL([VERSION]) -m4trace:configure.ac:34: -1- m4_pattern_allow([^VERSION$]) -m4trace:configure.ac:34: -1- AH_OUTPUT([VERSION], [/* Version number of package */ -@%:@undef VERSION]) -m4trace:configure.ac:34: -1- AC_REQUIRE_AUX_FILE([missing]) -m4trace:configure.ac:34: -1- AC_SUBST([ACLOCAL]) -m4trace:configure.ac:34: -1- AC_SUBST_TRACE([ACLOCAL]) -m4trace:configure.ac:34: -1- m4_pattern_allow([^ACLOCAL$]) -m4trace:configure.ac:34: -1- AC_SUBST([AUTOCONF]) -m4trace:configure.ac:34: -1- AC_SUBST_TRACE([AUTOCONF]) -m4trace:configure.ac:34: -1- m4_pattern_allow([^AUTOCONF$]) -m4trace:configure.ac:34: -1- AC_SUBST([AUTOMAKE]) -m4trace:configure.ac:34: -1- AC_SUBST_TRACE([AUTOMAKE]) -m4trace:configure.ac:34: -1- m4_pattern_allow([^AUTOMAKE$]) -m4trace:configure.ac:34: -1- AC_SUBST([AUTOHEADER]) -m4trace:configure.ac:34: -1- AC_SUBST_TRACE([AUTOHEADER]) -m4trace:configure.ac:34: -1- m4_pattern_allow([^AUTOHEADER$]) -m4trace:configure.ac:34: -1- AC_SUBST([MAKEINFO]) -m4trace:configure.ac:34: -1- AC_SUBST_TRACE([MAKEINFO]) -m4trace:configure.ac:34: -1- m4_pattern_allow([^MAKEINFO$]) -m4trace:configure.ac:34: -1- AC_SUBST([install_sh]) -m4trace:configure.ac:34: -1- AC_SUBST_TRACE([install_sh]) -m4trace:configure.ac:34: -1- m4_pattern_allow([^install_sh$]) -m4trace:configure.ac:34: -1- AC_SUBST([STRIP]) -m4trace:configure.ac:34: -1- AC_SUBST_TRACE([STRIP]) -m4trace:configure.ac:34: -1- m4_pattern_allow([^STRIP$]) -m4trace:configure.ac:34: -1- AC_SUBST([INSTALL_STRIP_PROGRAM]) -m4trace:configure.ac:34: -1- AC_SUBST_TRACE([INSTALL_STRIP_PROGRAM]) -m4trace:configure.ac:34: -1- m4_pattern_allow([^INSTALL_STRIP_PROGRAM$]) -m4trace:configure.ac:34: -1- AC_REQUIRE_AUX_FILE([install-sh]) -m4trace:configure.ac:34: -1- AC_SUBST([MKDIR_P]) -m4trace:configure.ac:34: -1- AC_SUBST_TRACE([MKDIR_P]) -m4trace:configure.ac:34: -1- m4_pattern_allow([^MKDIR_P$]) -m4trace:configure.ac:34: -1- AC_SUBST([mkdir_p], ['$(MKDIR_P)']) -m4trace:configure.ac:34: -1- AC_SUBST_TRACE([mkdir_p]) -m4trace:configure.ac:34: -1- m4_pattern_allow([^mkdir_p$]) -m4trace:configure.ac:34: -1- AC_SUBST([AWK]) -m4trace:configure.ac:34: -1- AC_SUBST_TRACE([AWK]) -m4trace:configure.ac:34: -1- m4_pattern_allow([^AWK$]) -m4trace:configure.ac:34: -1- AC_SUBST([SET_MAKE]) -m4trace:configure.ac:34: -1- AC_SUBST_TRACE([SET_MAKE]) -m4trace:configure.ac:34: -1- m4_pattern_allow([^SET_MAKE$]) -m4trace:configure.ac:34: -1- AC_SUBST([am__leading_dot]) -m4trace:configure.ac:34: -1- AC_SUBST_TRACE([am__leading_dot]) -m4trace:configure.ac:34: -1- m4_pattern_allow([^am__leading_dot$]) -m4trace:configure.ac:34: -1- AC_SUBST([AMTAR], ['$${TAR-tar}']) -m4trace:configure.ac:34: -1- AC_SUBST_TRACE([AMTAR]) -m4trace:configure.ac:34: -1- m4_pattern_allow([^AMTAR$]) -m4trace:configure.ac:34: -1- AC_SUBST([am__tar]) -m4trace:configure.ac:34: -1- AC_SUBST_TRACE([am__tar]) -m4trace:configure.ac:34: -1- m4_pattern_allow([^am__tar$]) -m4trace:configure.ac:34: -1- AC_SUBST([am__untar]) -m4trace:configure.ac:34: -1- AC_SUBST_TRACE([am__untar]) -m4trace:configure.ac:34: -1- m4_pattern_allow([^am__untar$]) -m4trace:configure.ac:34: -1- AM_SILENT_RULES -m4trace:configure.ac:34: -1- AC_SUBST([AM_V]) -m4trace:configure.ac:34: -1- AC_SUBST_TRACE([AM_V]) -m4trace:configure.ac:34: -1- m4_pattern_allow([^AM_V$]) -m4trace:configure.ac:34: -1- _AM_SUBST_NOTMAKE([AM_V]) -m4trace:configure.ac:34: -1- AC_SUBST([AM_DEFAULT_V]) -m4trace:configure.ac:34: -1- AC_SUBST_TRACE([AM_DEFAULT_V]) -m4trace:configure.ac:34: -1- m4_pattern_allow([^AM_DEFAULT_V$]) -m4trace:configure.ac:34: -1- _AM_SUBST_NOTMAKE([AM_DEFAULT_V]) -m4trace:configure.ac:34: -1- AC_SUBST([AM_DEFAULT_VERBOSITY]) -m4trace:configure.ac:34: -1- AC_SUBST_TRACE([AM_DEFAULT_VERBOSITY]) -m4trace:configure.ac:34: -1- m4_pattern_allow([^AM_DEFAULT_VERBOSITY$]) -m4trace:configure.ac:34: -1- AC_SUBST([AM_BACKSLASH]) -m4trace:configure.ac:34: -1- AC_SUBST_TRACE([AM_BACKSLASH]) -m4trace:configure.ac:34: -1- m4_pattern_allow([^AM_BACKSLASH$]) -m4trace:configure.ac:34: -1- _AM_SUBST_NOTMAKE([AM_BACKSLASH]) -m4trace:configure.ac:36: -1- AC_SUBST([CC]) -m4trace:configure.ac:36: -1- AC_SUBST_TRACE([CC]) -m4trace:configure.ac:36: -1- m4_pattern_allow([^CC$]) -m4trace:configure.ac:36: -1- AC_SUBST([CFLAGS]) -m4trace:configure.ac:36: -1- AC_SUBST_TRACE([CFLAGS]) -m4trace:configure.ac:36: -1- m4_pattern_allow([^CFLAGS$]) -m4trace:configure.ac:36: -1- AC_SUBST([LDFLAGS]) -m4trace:configure.ac:36: -1- AC_SUBST_TRACE([LDFLAGS]) -m4trace:configure.ac:36: -1- m4_pattern_allow([^LDFLAGS$]) -m4trace:configure.ac:36: -1- AC_SUBST([LIBS]) -m4trace:configure.ac:36: -1- AC_SUBST_TRACE([LIBS]) -m4trace:configure.ac:36: -1- m4_pattern_allow([^LIBS$]) -m4trace:configure.ac:36: -1- AC_SUBST([CPPFLAGS]) -m4trace:configure.ac:36: -1- AC_SUBST_TRACE([CPPFLAGS]) -m4trace:configure.ac:36: -1- m4_pattern_allow([^CPPFLAGS$]) -m4trace:configure.ac:36: -1- AC_SUBST([CC]) -m4trace:configure.ac:36: -1- AC_SUBST_TRACE([CC]) -m4trace:configure.ac:36: -1- m4_pattern_allow([^CC$]) -m4trace:configure.ac:36: -1- AC_SUBST([CC]) -m4trace:configure.ac:36: -1- AC_SUBST_TRACE([CC]) -m4trace:configure.ac:36: -1- m4_pattern_allow([^CC$]) -m4trace:configure.ac:36: -1- AC_SUBST([CC]) -m4trace:configure.ac:36: -1- AC_SUBST_TRACE([CC]) -m4trace:configure.ac:36: -1- m4_pattern_allow([^CC$]) -m4trace:configure.ac:36: -1- AC_SUBST([CC]) -m4trace:configure.ac:36: -1- AC_SUBST_TRACE([CC]) -m4trace:configure.ac:36: -1- m4_pattern_allow([^CC$]) -m4trace:configure.ac:36: -1- AC_SUBST([ac_ct_CC]) -m4trace:configure.ac:36: -1- AC_SUBST_TRACE([ac_ct_CC]) -m4trace:configure.ac:36: -1- m4_pattern_allow([^ac_ct_CC$]) -m4trace:configure.ac:36: -1- AC_SUBST([EXEEXT], [$ac_cv_exeext]) -m4trace:configure.ac:36: -1- AC_SUBST_TRACE([EXEEXT]) -m4trace:configure.ac:36: -1- m4_pattern_allow([^EXEEXT$]) -m4trace:configure.ac:36: -1- AC_SUBST([OBJEXT], [$ac_cv_objext]) -m4trace:configure.ac:36: -1- AC_SUBST_TRACE([OBJEXT]) -m4trace:configure.ac:36: -1- m4_pattern_allow([^OBJEXT$]) -m4trace:configure.ac:36: -1- AC_REQUIRE_AUX_FILE([compile]) -m4trace:configure.ac:36: -1- AC_SUBST([DEPDIR], ["${am__leading_dot}deps"]) -m4trace:configure.ac:36: -1- AC_SUBST_TRACE([DEPDIR]) -m4trace:configure.ac:36: -1- m4_pattern_allow([^DEPDIR$]) -m4trace:configure.ac:36: -1- AC_SUBST([am__include]) -m4trace:configure.ac:36: -1- AC_SUBST_TRACE([am__include]) -m4trace:configure.ac:36: -1- m4_pattern_allow([^am__include$]) -m4trace:configure.ac:36: -1- AC_SUBST([am__quote]) -m4trace:configure.ac:36: -1- AC_SUBST_TRACE([am__quote]) -m4trace:configure.ac:36: -1- m4_pattern_allow([^am__quote$]) -m4trace:configure.ac:36: -1- AM_CONDITIONAL([AMDEP], [test "x$enable_dependency_tracking" != xno]) -m4trace:configure.ac:36: -1- AC_SUBST([AMDEP_TRUE]) -m4trace:configure.ac:36: -1- AC_SUBST_TRACE([AMDEP_TRUE]) -m4trace:configure.ac:36: -1- m4_pattern_allow([^AMDEP_TRUE$]) -m4trace:configure.ac:36: -1- AC_SUBST([AMDEP_FALSE]) -m4trace:configure.ac:36: -1- AC_SUBST_TRACE([AMDEP_FALSE]) -m4trace:configure.ac:36: -1- m4_pattern_allow([^AMDEP_FALSE$]) -m4trace:configure.ac:36: -1- _AM_SUBST_NOTMAKE([AMDEP_TRUE]) -m4trace:configure.ac:36: -1- _AM_SUBST_NOTMAKE([AMDEP_FALSE]) -m4trace:configure.ac:36: -1- AC_SUBST([AMDEPBACKSLASH]) -m4trace:configure.ac:36: -1- AC_SUBST_TRACE([AMDEPBACKSLASH]) -m4trace:configure.ac:36: -1- m4_pattern_allow([^AMDEPBACKSLASH$]) -m4trace:configure.ac:36: -1- _AM_SUBST_NOTMAKE([AMDEPBACKSLASH]) -m4trace:configure.ac:36: -1- AC_SUBST([am__nodep]) -m4trace:configure.ac:36: -1- AC_SUBST_TRACE([am__nodep]) -m4trace:configure.ac:36: -1- m4_pattern_allow([^am__nodep$]) -m4trace:configure.ac:36: -1- _AM_SUBST_NOTMAKE([am__nodep]) -m4trace:configure.ac:36: -1- AC_SUBST([CCDEPMODE], [depmode=$am_cv_CC_dependencies_compiler_type]) -m4trace:configure.ac:36: -1- AC_SUBST_TRACE([CCDEPMODE]) -m4trace:configure.ac:36: -1- m4_pattern_allow([^CCDEPMODE$]) -m4trace:configure.ac:36: -1- AM_CONDITIONAL([am__fastdepCC], [ - test "x$enable_dependency_tracking" != xno \ - && test "$am_cv_CC_dependencies_compiler_type" = gcc3]) -m4trace:configure.ac:36: -1- AC_SUBST([am__fastdepCC_TRUE]) -m4trace:configure.ac:36: -1- AC_SUBST_TRACE([am__fastdepCC_TRUE]) -m4trace:configure.ac:36: -1- m4_pattern_allow([^am__fastdepCC_TRUE$]) -m4trace:configure.ac:36: -1- AC_SUBST([am__fastdepCC_FALSE]) -m4trace:configure.ac:36: -1- AC_SUBST_TRACE([am__fastdepCC_FALSE]) -m4trace:configure.ac:36: -1- m4_pattern_allow([^am__fastdepCC_FALSE$]) -m4trace:configure.ac:36: -1- _AM_SUBST_NOTMAKE([am__fastdepCC_TRUE]) -m4trace:configure.ac:36: -1- _AM_SUBST_NOTMAKE([am__fastdepCC_FALSE]) -m4trace:configure.ac:37: -1- AC_SUBST([CXX]) -m4trace:configure.ac:37: -1- AC_SUBST_TRACE([CXX]) -m4trace:configure.ac:37: -1- m4_pattern_allow([^CXX$]) -m4trace:configure.ac:37: -1- AC_SUBST([CXXFLAGS]) -m4trace:configure.ac:37: -1- AC_SUBST_TRACE([CXXFLAGS]) -m4trace:configure.ac:37: -1- m4_pattern_allow([^CXXFLAGS$]) -m4trace:configure.ac:37: -1- AC_SUBST([LDFLAGS]) -m4trace:configure.ac:37: -1- AC_SUBST_TRACE([LDFLAGS]) -m4trace:configure.ac:37: -1- m4_pattern_allow([^LDFLAGS$]) -m4trace:configure.ac:37: -1- AC_SUBST([LIBS]) -m4trace:configure.ac:37: -1- AC_SUBST_TRACE([LIBS]) -m4trace:configure.ac:37: -1- m4_pattern_allow([^LIBS$]) -m4trace:configure.ac:37: -1- AC_SUBST([CPPFLAGS]) -m4trace:configure.ac:37: -1- AC_SUBST_TRACE([CPPFLAGS]) -m4trace:configure.ac:37: -1- m4_pattern_allow([^CPPFLAGS$]) -m4trace:configure.ac:37: -1- AC_SUBST([CXX]) -m4trace:configure.ac:37: -1- AC_SUBST_TRACE([CXX]) -m4trace:configure.ac:37: -1- m4_pattern_allow([^CXX$]) -m4trace:configure.ac:37: -1- AC_SUBST([ac_ct_CXX]) -m4trace:configure.ac:37: -1- AC_SUBST_TRACE([ac_ct_CXX]) -m4trace:configure.ac:37: -1- m4_pattern_allow([^ac_ct_CXX$]) -m4trace:configure.ac:37: -1- AC_SUBST([CXXDEPMODE], [depmode=$am_cv_CXX_dependencies_compiler_type]) -m4trace:configure.ac:37: -1- AC_SUBST_TRACE([CXXDEPMODE]) -m4trace:configure.ac:37: -1- m4_pattern_allow([^CXXDEPMODE$]) -m4trace:configure.ac:37: -1- AM_CONDITIONAL([am__fastdepCXX], [ - test "x$enable_dependency_tracking" != xno \ - && test "$am_cv_CXX_dependencies_compiler_type" = gcc3]) -m4trace:configure.ac:37: -1- AC_SUBST([am__fastdepCXX_TRUE]) -m4trace:configure.ac:37: -1- AC_SUBST_TRACE([am__fastdepCXX_TRUE]) -m4trace:configure.ac:37: -1- m4_pattern_allow([^am__fastdepCXX_TRUE$]) -m4trace:configure.ac:37: -1- AC_SUBST([am__fastdepCXX_FALSE]) -m4trace:configure.ac:37: -1- AC_SUBST_TRACE([am__fastdepCXX_FALSE]) -m4trace:configure.ac:37: -1- m4_pattern_allow([^am__fastdepCXX_FALSE$]) -m4trace:configure.ac:37: -1- _AM_SUBST_NOTMAKE([am__fastdepCXX_TRUE]) -m4trace:configure.ac:37: -1- _AM_SUBST_NOTMAKE([am__fastdepCXX_FALSE]) -m4trace:configure.ac:38: -1- AC_SUBST([CPP]) -m4trace:configure.ac:38: -1- AC_SUBST_TRACE([CPP]) -m4trace:configure.ac:38: -1- m4_pattern_allow([^CPP$]) -m4trace:configure.ac:38: -1- AC_SUBST([CPPFLAGS]) -m4trace:configure.ac:38: -1- AC_SUBST_TRACE([CPPFLAGS]) -m4trace:configure.ac:38: -1- m4_pattern_allow([^CPPFLAGS$]) -m4trace:configure.ac:38: -1- AC_SUBST([CPP]) -m4trace:configure.ac:38: -1- AC_SUBST_TRACE([CPP]) -m4trace:configure.ac:38: -1- m4_pattern_allow([^CPP$]) -m4trace:configure.ac:39: -1- AC_SUBST([FC]) -m4trace:configure.ac:39: -1- AC_SUBST_TRACE([FC]) -m4trace:configure.ac:39: -1- m4_pattern_allow([^FC$]) -m4trace:configure.ac:39: -1- AC_SUBST([FCFLAGS]) -m4trace:configure.ac:39: -1- AC_SUBST_TRACE([FCFLAGS]) -m4trace:configure.ac:39: -1- m4_pattern_allow([^FCFLAGS$]) -m4trace:configure.ac:39: -1- AC_SUBST([LDFLAGS]) -m4trace:configure.ac:39: -1- AC_SUBST_TRACE([LDFLAGS]) -m4trace:configure.ac:39: -1- m4_pattern_allow([^LDFLAGS$]) -m4trace:configure.ac:39: -1- AC_SUBST([LIBS]) -m4trace:configure.ac:39: -1- AC_SUBST_TRACE([LIBS]) -m4trace:configure.ac:39: -1- m4_pattern_allow([^LIBS$]) -m4trace:configure.ac:39: -1- AC_SUBST([FC]) -m4trace:configure.ac:39: -1- AC_SUBST_TRACE([FC]) -m4trace:configure.ac:39: -1- m4_pattern_allow([^FC$]) -m4trace:configure.ac:39: -1- AC_SUBST([ac_ct_FC]) -m4trace:configure.ac:39: -1- AC_SUBST_TRACE([ac_ct_FC]) -m4trace:configure.ac:39: -1- m4_pattern_allow([^ac_ct_FC$]) -m4trace:configure.ac:40: -1- AC_SUBST([RANLIB]) -m4trace:configure.ac:40: -1- AC_SUBST_TRACE([RANLIB]) -m4trace:configure.ac:40: -1- m4_pattern_allow([^RANLIB$]) -m4trace:configure.ac:42: -1- AC_SUBST([LN_S], [$as_ln_s]) -m4trace:configure.ac:42: -1- AC_SUBST_TRACE([LN_S]) -m4trace:configure.ac:42: -1- m4_pattern_allow([^LN_S$]) -m4trace:configure.ac:43: -1- AC_SUBST([SET_MAKE]) -m4trace:configure.ac:43: -1- AC_SUBST_TRACE([SET_MAKE]) -m4trace:configure.ac:43: -1- m4_pattern_allow([^SET_MAKE$]) -m4trace:configure.ac:45: -1- AC_SUBST([GREP]) -m4trace:configure.ac:45: -1- AC_SUBST_TRACE([GREP]) -m4trace:configure.ac:45: -1- m4_pattern_allow([^GREP$]) -m4trace:configure.ac:45: -1- AC_SUBST([EGREP]) -m4trace:configure.ac:45: -1- AC_SUBST_TRACE([EGREP]) -m4trace:configure.ac:45: -1- m4_pattern_allow([^EGREP$]) -m4trace:configure.ac:45: -1- AC_DEFINE_TRACE_LITERAL([STDC_HEADERS]) -m4trace:configure.ac:45: -1- m4_pattern_allow([^STDC_HEADERS$]) -m4trace:configure.ac:45: -1- AH_OUTPUT([STDC_HEADERS], [/* Define to 1 if you have the ANSI C header files. */ -@%:@undef STDC_HEADERS]) -m4trace:configure.ac:47: -1- AH_OUTPUT([HAVE_SYS_TYPES_H], [/* Define to 1 if you have the header file. */ -@%:@undef HAVE_SYS_TYPES_H]) -m4trace:configure.ac:47: -1- AH_OUTPUT([HAVE_SYS_STAT_H], [/* Define to 1 if you have the header file. */ -@%:@undef HAVE_SYS_STAT_H]) -m4trace:configure.ac:47: -1- AH_OUTPUT([HAVE_STDLIB_H], [/* Define to 1 if you have the header file. */ -@%:@undef HAVE_STDLIB_H]) -m4trace:configure.ac:47: -1- AH_OUTPUT([HAVE_STRING_H], [/* Define to 1 if you have the header file. */ -@%:@undef HAVE_STRING_H]) -m4trace:configure.ac:47: -1- AH_OUTPUT([HAVE_MEMORY_H], [/* Define to 1 if you have the header file. */ -@%:@undef HAVE_MEMORY_H]) -m4trace:configure.ac:47: -1- AH_OUTPUT([HAVE_STRINGS_H], [/* Define to 1 if you have the header file. */ -@%:@undef HAVE_STRINGS_H]) -m4trace:configure.ac:47: -1- AH_OUTPUT([HAVE_INTTYPES_H], [/* Define to 1 if you have the header file. */ -@%:@undef HAVE_INTTYPES_H]) -m4trace:configure.ac:47: -1- AH_OUTPUT([HAVE_STDINT_H], [/* Define to 1 if you have the header file. */ -@%:@undef HAVE_STDINT_H]) -m4trace:configure.ac:47: -1- AH_OUTPUT([HAVE_UNISTD_H], [/* Define to 1 if you have the header file. */ -@%:@undef HAVE_UNISTD_H]) -m4trace:configure.ac:47: -1- AC_DEFINE_TRACE_LITERAL([size_t]) -m4trace:configure.ac:47: -1- m4_pattern_allow([^size_t$]) -m4trace:configure.ac:47: -1- AH_OUTPUT([size_t], [/* Define to `unsigned int\' if does not define. */ -@%:@undef size_t]) -m4trace:configure.ac:48: -1- AC_DEFINE_TRACE_LITERAL([TM_IN_SYS_TIME]) -m4trace:configure.ac:48: -1- m4_pattern_allow([^TM_IN_SYS_TIME$]) -m4trace:configure.ac:48: -1- AH_OUTPUT([TM_IN_SYS_TIME], [/* Define to 1 if your declares `struct tm\'. */ -@%:@undef TM_IN_SYS_TIME]) -m4trace:configure.ac:49: -1- AC_DEFINE_TRACE_LITERAL([const]) -m4trace:configure.ac:49: -1- m4_pattern_allow([^const$]) -m4trace:configure.ac:49: -1- AH_OUTPUT([const], [/* Define to empty if `const\' does not conform to ANSI C. */ -@%:@undef const]) -m4trace:configure.ac:50: -1- AH_OUTPUT([HAVE_STDLIB_H], [/* Define to 1 if you have the header file. */ -@%:@undef HAVE_STDLIB_H]) -m4trace:configure.ac:50: -1- AC_DEFINE_TRACE_LITERAL([HAVE_STDLIB_H]) -m4trace:configure.ac:50: -1- m4_pattern_allow([^HAVE_STDLIB_H$]) -m4trace:configure.ac:50: -1- AC_DEFINE_TRACE_LITERAL([HAVE_MALLOC]) -m4trace:configure.ac:50: -1- m4_pattern_allow([^HAVE_MALLOC$]) -m4trace:configure.ac:50: -1- AH_OUTPUT([HAVE_MALLOC], [/* Define to 1 if your system has a GNU libc compatible `malloc\' function, and - to 0 otherwise. */ -@%:@undef HAVE_MALLOC]) -m4trace:configure.ac:50: -1- AC_DEFINE_TRACE_LITERAL([HAVE_MALLOC]) -m4trace:configure.ac:50: -1- m4_pattern_allow([^HAVE_MALLOC$]) -m4trace:configure.ac:50: -1- AC_SUBST([LIB@&t@OBJS], ["$LIB@&t@OBJS malloc.$ac_objext"]) -m4trace:configure.ac:50: -1- AC_SUBST_TRACE([LIB@&t@OBJS]) -m4trace:configure.ac:50: -1- m4_pattern_allow([^LIB@&t@OBJS$]) -m4trace:configure.ac:50: -1- AC_LIBSOURCE([malloc.c]) -m4trace:configure.ac:50: -1- AC_DEFINE_TRACE_LITERAL([malloc]) -m4trace:configure.ac:50: -1- m4_pattern_allow([^malloc$]) -m4trace:configure.ac:50: -1- AH_OUTPUT([malloc], [/* Define to rpl_malloc if the replacement function should be used. */ -@%:@undef malloc]) -m4trace:configure.ac:52: -1- AC_SUBST([FC_MODINC]) -m4trace:configure.ac:52: -1- AC_SUBST_TRACE([FC_MODINC]) -m4trace:configure.ac:52: -1- m4_pattern_allow([^FC_MODINC$]) -m4trace:configure.ac:52: -1- AC_SUBST([ac_empty], [""]) -m4trace:configure.ac:52: -1- AC_SUBST_TRACE([ac_empty]) -m4trace:configure.ac:52: -1- m4_pattern_allow([^ac_empty$]) -m4trace:configure.ac:53: -1- AC_SUBST([FC_MODOUT]) -m4trace:configure.ac:53: -1- AC_SUBST_TRACE([FC_MODOUT]) -m4trace:configure.ac:53: -1- m4_pattern_allow([^FC_MODOUT$]) -m4trace:configure.ac:53: -1- AC_SUBST([ac_empty], [""]) -m4trace:configure.ac:53: -1- AC_SUBST_TRACE([ac_empty]) -m4trace:configure.ac:53: -1- m4_pattern_allow([^ac_empty$]) -m4trace:configure.ac:54: -1- AC_SUBST([FC_MODEXT]) -m4trace:configure.ac:54: -1- AC_SUBST_TRACE([FC_MODEXT]) -m4trace:configure.ac:54: -1- m4_pattern_allow([^FC_MODEXT$]) -m4trace:configure.ac:72: -1- AH_OUTPUT([HAVE_FITSIO_H], [/* Define to 1 if you have the header file. */ -@%:@undef HAVE_FITSIO_H]) -m4trace:configure.ac:72: -1- AC_DEFINE_TRACE_LITERAL([HAVE_FITSIO_H]) -m4trace:configure.ac:72: -1- m4_pattern_allow([^HAVE_FITSIO_H$]) -m4trace:configure.ac:73: -2- AC_SUBST([LIBCFITSIO], [-lcfitsio]) -m4trace:configure.ac:73: -2- AC_SUBST_TRACE([LIBCFITSIO]) -m4trace:configure.ac:73: -2- m4_pattern_allow([^LIBCFITSIO$]) -m4trace:configure.ac:78: -1- AH_OUTPUT([HAVE_LIBMINPACK], [/* Define to 1 if you have the `minpack\' library (-lminpack). */ -@%:@undef HAVE_LIBMINPACK]) -m4trace:configure.ac:78: -1- AC_DEFINE_TRACE_LITERAL([HAVE_LIBMINPACK]) -m4trace:configure.ac:78: -1- m4_pattern_allow([^HAVE_LIBMINPACK$]) -m4trace:configure.ac:78: -1- AC_SUBST([F77]) -m4trace:configure.ac:78: -1- AC_SUBST_TRACE([F77]) -m4trace:configure.ac:78: -1- m4_pattern_allow([^F77$]) -m4trace:configure.ac:78: -1- AC_SUBST([FFLAGS]) -m4trace:configure.ac:78: -1- AC_SUBST_TRACE([FFLAGS]) -m4trace:configure.ac:78: -1- m4_pattern_allow([^FFLAGS$]) -m4trace:configure.ac:78: -1- AC_SUBST([LDFLAGS]) -m4trace:configure.ac:78: -1- AC_SUBST_TRACE([LDFLAGS]) -m4trace:configure.ac:78: -1- m4_pattern_allow([^LDFLAGS$]) -m4trace:configure.ac:78: -1- AC_SUBST([LIBS]) -m4trace:configure.ac:78: -1- AC_SUBST_TRACE([LIBS]) -m4trace:configure.ac:78: -1- m4_pattern_allow([^LIBS$]) -m4trace:configure.ac:78: -1- AC_SUBST([F77]) -m4trace:configure.ac:78: -1- AC_SUBST_TRACE([F77]) -m4trace:configure.ac:78: -1- m4_pattern_allow([^F77$]) -m4trace:configure.ac:78: -1- AC_SUBST([ac_ct_F77]) -m4trace:configure.ac:78: -1- AC_SUBST_TRACE([ac_ct_F77]) -m4trace:configure.ac:78: -1- m4_pattern_allow([^ac_ct_F77$]) -m4trace:configure.ac:78: -1- AC_SUBST([MINPACKDIR], [minpack]) -m4trace:configure.ac:78: -1- AC_SUBST_TRACE([MINPACKDIR]) -m4trace:configure.ac:78: -1- m4_pattern_allow([^MINPACKDIR$]) -m4trace:configure.ac:78: -1- AC_SUBST([LDMINPACK], [-L../minpack]) -m4trace:configure.ac:78: -1- AC_SUBST_TRACE([LDMINPACK]) -m4trace:configure.ac:78: -1- m4_pattern_allow([^LDMINPACK$]) -m4trace:configure.ac:84: -2- _m4_warn([obsolete], [The macro `AC_HELP_STRING' is obsolete. -You should run autoupdate.], [../../lib/autoconf/general.m4:207: AC_HELP_STRING is expanded from... -configure.ac:84: the top level]) -m4trace:configure.ac:85: -2- _m4_warn([obsolete], [The macro `AC_HELP_STRING' is obsolete. -You should run autoupdate.], [../../lib/autoconf/general.m4:207: AC_HELP_STRING is expanded from... -configure.ac:85: the top level]) -m4trace:configure.ac:86: -2- _m4_warn([obsolete], [The macro `AC_HELP_STRING' is obsolete. -You should run autoupdate.], [../../lib/autoconf/general.m4:207: AC_HELP_STRING is expanded from... -configure.ac:86: the top level]) -m4trace:configure.ac:92: -1- AC_SUBST([WX_CONFIG_PATH]) -m4trace:configure.ac:92: -1- AC_SUBST_TRACE([WX_CONFIG_PATH]) -m4trace:configure.ac:92: -1- m4_pattern_allow([^WX_CONFIG_PATH$]) -m4trace:configure.ac:92: -1- AC_SUBST([WX_CPPFLAGS]) -m4trace:configure.ac:92: -1- AC_SUBST_TRACE([WX_CPPFLAGS]) -m4trace:configure.ac:92: -1- m4_pattern_allow([^WX_CPPFLAGS$]) -m4trace:configure.ac:92: -1- AC_SUBST([WX_CFLAGS]) -m4trace:configure.ac:92: -1- AC_SUBST_TRACE([WX_CFLAGS]) -m4trace:configure.ac:92: -1- m4_pattern_allow([^WX_CFLAGS$]) -m4trace:configure.ac:92: -1- AC_SUBST([WX_CXXFLAGS]) -m4trace:configure.ac:92: -1- AC_SUBST_TRACE([WX_CXXFLAGS]) -m4trace:configure.ac:92: -1- m4_pattern_allow([^WX_CXXFLAGS$]) -m4trace:configure.ac:92: -1- AC_SUBST([WX_CFLAGS_ONLY]) -m4trace:configure.ac:92: -1- AC_SUBST_TRACE([WX_CFLAGS_ONLY]) -m4trace:configure.ac:92: -1- m4_pattern_allow([^WX_CFLAGS_ONLY$]) -m4trace:configure.ac:92: -1- AC_SUBST([WX_CXXFLAGS_ONLY]) -m4trace:configure.ac:92: -1- AC_SUBST_TRACE([WX_CXXFLAGS_ONLY]) -m4trace:configure.ac:92: -1- m4_pattern_allow([^WX_CXXFLAGS_ONLY$]) -m4trace:configure.ac:92: -1- AC_SUBST([WX_LIBS]) -m4trace:configure.ac:92: -1- AC_SUBST_TRACE([WX_LIBS]) -m4trace:configure.ac:92: -1- m4_pattern_allow([^WX_LIBS$]) -m4trace:configure.ac:92: -1- AC_SUBST([WX_LIBS_STATIC]) -m4trace:configure.ac:92: -1- AC_SUBST_TRACE([WX_LIBS_STATIC]) -m4trace:configure.ac:92: -1- m4_pattern_allow([^WX_LIBS_STATIC$]) -m4trace:configure.ac:92: -1- AC_SUBST([WX_VERSION]) -m4trace:configure.ac:92: -1- AC_SUBST_TRACE([WX_VERSION]) -m4trace:configure.ac:92: -1- m4_pattern_allow([^WX_VERSION$]) -m4trace:configure.ac:92: -1- AC_SUBST([WX_RESCOMP]) -m4trace:configure.ac:92: -1- AC_SUBST_TRACE([WX_RESCOMP]) -m4trace:configure.ac:92: -1- m4_pattern_allow([^WX_RESCOMP$]) -m4trace:configure.ac:92: -1- AC_SUBST([WX_VERSION_MAJOR]) -m4trace:configure.ac:92: -1- AC_SUBST_TRACE([WX_VERSION_MAJOR]) -m4trace:configure.ac:92: -1- m4_pattern_allow([^WX_VERSION_MAJOR$]) -m4trace:configure.ac:92: -1- AC_SUBST([WX_VERSION_MINOR]) -m4trace:configure.ac:92: -1- AC_SUBST_TRACE([WX_VERSION_MINOR]) -m4trace:configure.ac:92: -1- m4_pattern_allow([^WX_VERSION_MINOR$]) -m4trace:configure.ac:92: -1- AC_SUBST([WX_VERSION_MICRO]) -m4trace:configure.ac:92: -1- AC_SUBST_TRACE([WX_VERSION_MICRO]) -m4trace:configure.ac:92: -1- m4_pattern_allow([^WX_VERSION_MICRO$]) -m4trace:configure.ac:129: -1- AC_SUBST([XMUNIPACKDIR], [xmunipack]) -m4trace:configure.ac:129: -1- AC_SUBST_TRACE([XMUNIPACKDIR]) -m4trace:configure.ac:129: -1- m4_pattern_allow([^XMUNIPACKDIR$]) -m4trace:configure.ac:130: -1- AC_SUBST([MATPLOTDIR], [wxMathPlot]) -m4trace:configure.ac:130: -1- AC_SUBST_TRACE([MATPLOTDIR]) -m4trace:configure.ac:130: -1- m4_pattern_allow([^MATPLOTDIR$]) -m4trace:configure.ac:135: -1- AC_SUBST([MUNIPACKDIR], [munipack]) -m4trace:configure.ac:135: -1- AC_SUBST_TRACE([MUNIPACKDIR]) -m4trace:configure.ac:135: -1- m4_pattern_allow([^MUNIPACKDIR$]) -m4trace:configure.ac:136: -1- AC_SUBST([WX_CXXFLAGS_CLI], [`wx-config --cxxflags base`]) -m4trace:configure.ac:136: -1- AC_SUBST_TRACE([WX_CXXFLAGS_CLI]) -m4trace:configure.ac:136: -1- m4_pattern_allow([^WX_CXXFLAGS_CLI$]) -m4trace:configure.ac:137: -1- AC_SUBST([WX_LIBS_CLI], [`wx-config --libs base`]) -m4trace:configure.ac:137: -1- AC_SUBST_TRACE([WX_LIBS_CLI]) -m4trace:configure.ac:137: -1- m4_pattern_allow([^WX_LIBS_CLI$]) -m4trace:configure.ac:142: -1- AC_SUBST([WX_LIBS_VO], [`wx-config --libs base,net,xml`]) -m4trace:configure.ac:142: -1- AC_SUBST_TRACE([WX_LIBS_VO]) -m4trace:configure.ac:142: -1- m4_pattern_allow([^WX_LIBS_VO$]) -m4trace:configure.ac:143: -1- AC_SUBST([WX_CXXFLAGS_VO], [`wx-config --cxxflags base,net,xml`]) -m4trace:configure.ac:143: -1- AC_SUBST_TRACE([WX_CXXFLAGS_VO]) -m4trace:configure.ac:143: -1- m4_pattern_allow([^WX_CXXFLAGS_VO$]) -m4trace:configure.ac:144: -1- AC_SUBST([VODIR], [vo]) -m4trace:configure.ac:144: -1- AC_SUBST_TRACE([VODIR]) -m4trace:configure.ac:144: -1- m4_pattern_allow([^VODIR$]) -m4trace:configure.ac:149: -2- _m4_warn([obsolete], [The macro `AC_HELP_STRING' is obsolete. -You should run autoupdate.], [../../lib/autoconf/general.m4:207: AC_HELP_STRING is expanded from... -configure.ac:149: the top level]) -m4trace:configure.ac:150: -1- AM_CONDITIONAL([BUNDLE], [test "x$enable_bundle" = "xyes"]) -m4trace:configure.ac:150: -1- AC_SUBST([BUNDLE_TRUE]) -m4trace:configure.ac:150: -1- AC_SUBST_TRACE([BUNDLE_TRUE]) -m4trace:configure.ac:150: -1- m4_pattern_allow([^BUNDLE_TRUE$]) -m4trace:configure.ac:150: -1- AC_SUBST([BUNDLE_FALSE]) -m4trace:configure.ac:150: -1- AC_SUBST_TRACE([BUNDLE_FALSE]) -m4trace:configure.ac:150: -1- m4_pattern_allow([^BUNDLE_FALSE$]) -m4trace:configure.ac:150: -1- _AM_SUBST_NOTMAKE([BUNDLE_TRUE]) -m4trace:configure.ac:150: -1- _AM_SUBST_NOTMAKE([BUNDLE_FALSE]) -m4trace:configure.ac:153: -1- AC_SUBST([BUNDLEDIR]) -m4trace:configure.ac:153: -1- AC_SUBST_TRACE([BUNDLEDIR]) -m4trace:configure.ac:153: -1- m4_pattern_allow([^BUNDLEDIR$]) -m4trace:configure.ac:160: -1- AC_SUBST([LIBGFORTRAN], [-static-libgfortran]) -m4trace:configure.ac:160: -1- AC_SUBST_TRACE([LIBGFORTRAN]) -m4trace:configure.ac:160: -1- m4_pattern_allow([^LIBGFORTRAN$]) -m4trace:configure.ac:161: -1- AC_SUBST([LIBGCC], [-static-libgcc]) -m4trace:configure.ac:161: -1- AC_SUBST_TRACE([LIBGCC]) -m4trace:configure.ac:161: -1- m4_pattern_allow([^LIBGCC$]) -m4trace:configure.ac:162: -1- AC_SUBST([LIBSTDCPP], [-static-libstdc++]) -m4trace:configure.ac:162: -1- AC_SUBST_TRACE([LIBSTDCPP]) -m4trace:configure.ac:162: -1- m4_pattern_allow([^LIBSTDCPP$]) -m4trace:configure.ac:166: -1- AC_SUBST([CLEANFILES], [*.$FC_MODEXT]) -m4trace:configure.ac:166: -1- AC_SUBST_TRACE([CLEANFILES]) -m4trace:configure.ac:166: -1- m4_pattern_allow([^CLEANFILES$]) -m4trace:configure.ac:169: -1- AC_CONFIG_HEADERS([config.h]) -m4trace:configure.ac:171: -1- AC_CONFIG_FILES([minpack/Makefile lib/Makefile preprocess/Makefile - kombine/Makefile photometry/Makefile artificial/Makefile fitsut/Makefile - list/Makefile astrometry/Makefile coloring/Makefile vo/Makefile - munipack/Makefile wxMathPlot/Makefile xmunipack/Makefile doc/Makefile - Makefile]) -m4trace:configure.ac:177: -1- AC_SUBST([LIB@&t@OBJS], [$ac_libobjs]) -m4trace:configure.ac:177: -1- AC_SUBST_TRACE([LIB@&t@OBJS]) -m4trace:configure.ac:177: -1- m4_pattern_allow([^LIB@&t@OBJS$]) -m4trace:configure.ac:177: -1- AC_SUBST([LTLIBOBJS], [$ac_ltlibobjs]) -m4trace:configure.ac:177: -1- AC_SUBST_TRACE([LTLIBOBJS]) -m4trace:configure.ac:177: -1- m4_pattern_allow([^LTLIBOBJS$]) -m4trace:configure.ac:177: -1- AM_CONDITIONAL([am__EXEEXT], [test -n "$EXEEXT"]) -m4trace:configure.ac:177: -1- AC_SUBST([am__EXEEXT_TRUE]) -m4trace:configure.ac:177: -1- AC_SUBST_TRACE([am__EXEEXT_TRUE]) -m4trace:configure.ac:177: -1- m4_pattern_allow([^am__EXEEXT_TRUE$]) -m4trace:configure.ac:177: -1- AC_SUBST([am__EXEEXT_FALSE]) -m4trace:configure.ac:177: -1- AC_SUBST_TRACE([am__EXEEXT_FALSE]) -m4trace:configure.ac:177: -1- m4_pattern_allow([^am__EXEEXT_FALSE$]) -m4trace:configure.ac:177: -1- _AM_SUBST_NOTMAKE([am__EXEEXT_TRUE]) -m4trace:configure.ac:177: -1- _AM_SUBST_NOTMAKE([am__EXEEXT_FALSE]) -m4trace:configure.ac:177: -1- AC_SUBST_TRACE([top_builddir]) -m4trace:configure.ac:177: -1- AC_SUBST_TRACE([top_build_prefix]) -m4trace:configure.ac:177: -1- AC_SUBST_TRACE([srcdir]) -m4trace:configure.ac:177: -1- AC_SUBST_TRACE([abs_srcdir]) -m4trace:configure.ac:177: -1- AC_SUBST_TRACE([top_srcdir]) -m4trace:configure.ac:177: -1- AC_SUBST_TRACE([abs_top_srcdir]) -m4trace:configure.ac:177: -1- AC_SUBST_TRACE([builddir]) -m4trace:configure.ac:177: -1- AC_SUBST_TRACE([abs_builddir]) -m4trace:configure.ac:177: -1- AC_SUBST_TRACE([abs_top_builddir]) -m4trace:configure.ac:177: -1- AC_SUBST_TRACE([INSTALL]) -m4trace:configure.ac:177: -1- AC_SUBST_TRACE([MKDIR_P]) diff -Nru munipack-0.5.9/ChangeLog munipack-0.5.10/ChangeLog --- munipack-0.5.9/ChangeLog 2017-07-17 23:04:22.000000000 +0000 +++ munipack-0.5.10/ChangeLog 2018-01-16 17:58:06.000000000 +0000 @@ -1,8 +1,189 @@ +2018-01-16 Filip Hroch + + * .hgtags: + Added tag 0.5.10 for changeset 9901903b0208 + [7050bdf14f66] [tip] + + * configure.ac, include/version.h, munipack/munipack.1, + munipack/munipack.cpp, vo/votable.cpp, xmunipack/xmunipack.1: + Corrected recent Vizier obscurity. Updated autoconfig version. + [9901903b0208] [0.5.10] + +2018-01-11 Filip Hroch + + * doc/Makefile.am, doc/cbasic.shtml, doc/changes.shtml, + doc/classics.shtml, doc/colorcal.shtml, doc/colorspace.shtml, + doc/ctutorial.shtml, doc/dataform_proc.shtml, doc/docs.shtml, + doc/grow.shtml, doc/guide.shtml, doc/itone.shtml, doc/lctut.shtml, + doc/man_astrometry.shtml, doc/man_bias.shtml, doc/man_com.shtml, + doc/man_cone.shtml, doc/man_flat.shtml, doc/munipack-atom.py, + doc/phcalibration.shtml, munipack/cmd.cpp: + Bugfix of htmls. + [1611370e9d90] + +2018-01-09 Filip Hroch + + * doc/Makefile.am, doc/changes.shtml, doc/flatfielding.shtml, + doc/man_artificial.shtml, doc/man_flat.shtml, doc/munipack.shtml, + include/version.h, lib/fitsio.f95: + Updated docs. + [dab76371ebdc] + +2017-12-27 Filip Hroch + + * doc/Makefile.am, doc/flatdebug_3.svg, doc/flatdebug_zero.svg, + doc/flatfielding.png, doc/flatfielding.shtml, doc/flatfine.png, + doc/flatzero.png, doc/foot.shtml, doc/guide.shtml, doc/head.shtml, + doc/man_flat.shtml, doc/man_setup.shtml, doc/munipack-atom.py, + doc/munipack.shtml, doc/notfound.shtml, doc/wrinkledflat.svg, + doc/wrinkledflat.tex, munipack/cmd.cpp, munipack/flat.cpp, + preprocess/flat.f95, preprocess/flat_debug.sh, + preprocess/phcorr.f95, preprocess/rflat.f08: + Prepared flat-fielding doc, improved flat manual and flat source + code. + [dec620afafdf] + +2017-12-07 Filip Hroch + + * lib/astrosphere.f95, lib/photoconv.f95, preprocess/rflat.f08: + Bugfix: flats normalisation for (n<3), the longitude sign in LMST. + [87ac77c19fea] + +2017-11-12 Filip Hroch + + * preprocess/flat.f95, xmunipack/astrometry.cpp, + xmunipack/discanvas.cpp, xmunipack/fits.cpp: + Bugfix in star draw layer of astrometry in viewer. + [6c66cb29f7b4] + +2017-10-23 Filip Hroch + + * preprocess/flat.f95, preprocess/rflat.f08: + Bugfixing of flat-fielding. + [890d9a7b8125] + + * bootstrap-dev, doc/man_flat.shtml, munipack/cmd.cpp, + munipack/flat.cpp, preprocess/flat.f95, preprocess/rflat.f08: + Perfecting flat algorithm, also removed --level, added bitmask. + [5706d199466a] + +2017-10-19 Filip Hroch + + * doc/lctut.sh, lib/liblist.f95, preprocess/Makefile.am, + preprocess/flat.f95, preprocess/rflat.f08: + Perfecting flat. Statistically correct residuals (histograms). + [c10921dff36f] + +2017-10-13 Filip Hroch + + * lib/escale.f95, lib/liblist.f95, lib/robratio.f08, lib/rwmean.f95, + photometry/daofotometr.f95, photometry/mfits.f95, + photometry/phcal.f95, preprocess/flat.f95: + Improvements of rwmean(), robratio() and new approach on flat-field. + [6d009ca5bb27] + +2017-10-09 Filip Hroch + + * astrometry/astrofits.f95, astrometry/astrometry.f95, + astrometry/match.f95, doc/man_astrometry.shtml, + munipack/astrometry.cpp, munipack/cmd.cpp, xmunipack/astrometry.cpp, + xmunipack/fits.cpp, xmunipack/fitscoo.cpp, xmunipack/xmunipack.h: + Astrometry perfecting. + [1a1be53912b9] + +2017-10-05 Filip Hroch + + * doc/man_bias.shtml, doc/man_dark.shtml, doc/man_kombine.shtml, + kombine/kombine.f95, lib/escale.f95, lib/rmean.f95, + lib/robratio.f08, lib/rwmean.f95, list/tmseries.f95, + munipack/cmd.cpp, munipack/common.cpp, munipack/kombine.cpp, + munipack/munipack.cpp, photometry/daofotometr.f95, + photometry/growcurve.f95, photometry/jam.f95, photometry/phcal.f95, + preprocess/flat.f95, preprocess/phcorr.f95, + xmunipack/astrometry.cpp, xmunipack/dispanel.cpp, + xmunipack/display.cpp, xmunipack/event.h, xmunipack/fits.cpp, + xmunipack/fits.h, xmunipack/fitscoo.cpp, xmunipack/view.cpp, + xmunipack/xmunipack.cpp, xmunipack/xmunipack.h: + Very important improvements of robratio and scale: + * Robust ratio has correct final (Newton) estimator + * Scale adaptive changes initial interval Both the improvemenst + drasticaly increases precision and reliability of photometry. + + Moreover, kombine has implemented initial reflectio and averaging as + alterative to summation. + [4ec213889542] + +2017-09-24 Filip Hroch + + * artificial/artificial.f95, artificial/generator.f95, + astrometry/absfit.f95, astrometry/astrofit.f95, + astrometry/astromatch.f95, astrometry/estimator.f95, + astrometry/robfit.f95, doc/artific.shtml, doc/man_artificial.shtml, + lib/escale.f95, munipack/artificial.cpp, munipack/cmd.cpp, + munipack/munipack.cpp, photometry/calibre.f95, + xmunipack/xmunipack.cpp: + Improved stability of robust astrometry, artificial background in + mags. + [e0736befa13a] + +2017-09-19 Filip Hroch + + * artificial/artest.sh, artificial/artificial.f95, + artificial/generator.f95, artificial/lcapprox.f08, + astrometry/absfit.f95, astrometry/astrofit.f95, + astrometry/astrofits.f95, astrometry/astromatch.f95, + astrometry/astrometry.f95, astrometry/estimator.f95, + astrometry/match.f95, astrometry/nearmatch.f95, + astrometry/robfit.f95, bootstrap-release, configure.ac, + doc/Makefile.am, doc/colorimage.shtml, doc/debbuilder.shtml, + doc/install.shtml, doc/lctut.sh, doc/m27.sh, + doc/man_artificial.shtml, doc/man_astrometry.shtml, + doc/man_ctrafo.shtml, doc/man_gphot.shtml, + doc/man_phcal_params.shtml, doc/man_phcorr.shtml, + doc/man_votable.shtml, doc/munipack-atom.py, doc/munipack.css, + doc/rpmbuilder.shtml, doc/title_logo.png, include/votable.h, + lib/escale.f95, lib/fitsio.f95, lib/photoconv.f95, lib/qmean.f95, + lib/rline.f95, lib/rmean.f95, lib/robratio.f08, lib/rwmean.f95, + list/mtable.f95, list/timeseries.f95, list/tmseries.f95, + munipack/astrometry.cpp, munipack/cmd.cpp, munipack/cone.cpp, + munipack/phcal.cpp, munipack/votable.cpp, photometry/aphot.f95, + photometry/calibre.f95, photometry/daofotometr.f95, + photometry/fitsaphot.f95, photometry/gphot.f95, + photometry/growcurve.f95, photometry/growfit.f95, + photometry/growmodel.f95, photometry/jam.f95, photometry/mfits.f95, + photometry/phcal.f95, photometry/sfits.f95, preprocess/phcorr.f95, + vo/votab.cpp, vo/votable.cpp, xmunipack/fits.h: + * All robust routines are updated for the correct estimate of scale + and standard errors. + * photometry: + daofotometr(!): correct estimates of errors, rwmean() + is sky estimator + fitsaphot(!): correct estimate of noise + + grow,phcal,mfits: developed better limit for bright star selection + + growmodel: bug-fix crash for one star only + phcal, photoconv: + estimates are no more normalised, allows to reach high precision for + long exposures + robratio(!): introduced new method for + regularisation which effectively suppress scatter of output data + * astrometry: introduced luckymatch + nearmatch: accepts only the + first match to prevent duplicity + match (!): corrected bad estimate + limit of Xi2 which didn't allow longer sequences + estimator: + corrected misuse of rmean() + astromatch: frame stars are also + sliced by brightness + * xmunipack: corrected missing values of int, char and bool in + spreadsheets + * list: upgraded time-date determination + * phcorr: bug-fix preventing crash by negative errors of frames + * votable: dimensions of output SVG canvas are adjustable by + parameters. + * artificial for lc: better handling of magnitudes, FITS header + improvements + * common: source code is adjusted to fit 80-columns, removed trailing + spaces + [0486a57f619a] + 2017-07-18 Filip Hroch * .hgtags: Added tag 0.5.9 for changeset 45845ff892bc - [6ce62a3b49b2] [tip] + [6ce62a3b49b2] 2017-07-17 Filip Hroch diff -Nru munipack-0.5.9/coloring/Makefile.in munipack-0.5.10/coloring/Makefile.in --- munipack-0.5.9/coloring/Makefile.in 2017-07-17 23:04:25.000000000 +0000 +++ munipack-0.5.10/coloring/Makefile.in 2018-01-16 17:58:15.000000000 +0000 @@ -303,7 +303,6 @@ builddir = @builddir@ datadir = @datadir@ datarootdir = @datarootdir@ -develop = @develop@ docdir = @docdir@ dvidir = @dvidir@ exec_prefix = @exec_prefix@ diff -Nru munipack-0.5.9/config.h.in munipack-0.5.10/config.h.in --- munipack-0.5.9/config.h.in 2017-07-17 23:04:25.000000000 +0000 +++ munipack-0.5.10/config.h.in 2018-01-16 17:58:13.000000000 +0000 @@ -1,11 +1,5 @@ /* config.h.in. Generated from configure.ac by autoheader. */ -/* configure time */ -#undef DATEBUILD - -/* indicates development build */ -#undef DEVELBUILD - /* Define to 1 if you have the header file. */ #undef HAVE_FITSIO_H diff -Nru munipack-0.5.9/configure munipack-0.5.10/configure --- munipack-0.5.9/configure 2017-07-17 23:04:25.000000000 +0000 +++ munipack-0.5.10/configure 2018-01-16 17:58:13.000000000 +0000 @@ -1,6 +1,6 @@ #! /bin/sh # Guess values for system-dependent variables and create Makefiles. -# Generated by GNU Autoconf 2.69 for Munipack 0.5.9. +# Generated by GNU Autoconf 2.69 for Munipack 0.5.10. # # Report bugs to >. # @@ -580,8 +580,8 @@ # Identity of this package. PACKAGE_NAME='Munipack' PACKAGE_TARNAME='munipack' -PACKAGE_VERSION='0.5.9' -PACKAGE_STRING='Munipack 0.5.9' +PACKAGE_VERSION='0.5.10' +PACKAGE_STRING='Munipack 0.5.10' PACKAGE_BUGREPORT='Filip Hroch ' PACKAGE_URL='http://munipack.physics.muni.cz' @@ -725,7 +725,6 @@ build_vendor build_cpu build -develop target_alias host_alias build_alias @@ -1346,7 +1345,7 @@ # Omit some internal or obsolete options to make the list less imposing. # This message is too long to be a string in the A/UX 3.1 sh. cat <<_ACEOF -\`configure' configures Munipack 0.5.9 to adapt to many kinds of systems. +\`configure' configures Munipack 0.5.10 to adapt to many kinds of systems. Usage: $0 [OPTION]... [VAR=VALUE]... @@ -1416,7 +1415,7 @@ if test -n "$ac_init_help"; then case $ac_init_help in - short | recursive ) echo "Configuration of Munipack 0.5.9:";; + short | recursive ) echo "Configuration of Munipack 0.5.10:";; esac cat <<\_ACEOF @@ -1529,7 +1528,7 @@ test -n "$ac_init_help" && exit $ac_status if $ac_init_version; then cat <<\_ACEOF -Munipack configure 0.5.9 +Munipack configure 0.5.10 generated by GNU Autoconf 2.69 Copyright (C) 2012 Free Software Foundation, Inc. @@ -1999,7 +1998,7 @@ This file contains any messages produced by compilers while running configure, to aid debugging if configure makes a mistake. -It was created by Munipack $as_me 0.5.9, which was +It was created by Munipack $as_me 0.5.10, which was generated by GNU Autoconf 2.69. Invocation command line was $ $0 $@ @@ -2348,18 +2347,6 @@ -develop=no - -if test "x$develop" = "xyes"; then - -$as_echo "#define DEVELBUILD 1" >>confdefs.h - - -cat >>confdefs.h <<_ACEOF -#define DATEBUILD `date +'"%F %T %Z"'` -_ACEOF - -fi ac_aux_dir= @@ -2916,7 +2903,7 @@ # Define the identity of the package. PACKAGE='munipack' - VERSION='0.5.9' + VERSION='0.5.10' cat >>confdefs.h <<_ACEOF @@ -5569,15 +5556,6 @@ fi - -case $build in - *solaris*) - CFITS_LIBS="-lnsl -lsocket" - ;; - *) - ;; -esac - for ac_header in fitsio.h do : ac_fn_c_check_header_mongrel "$LINENO" "fitsio.h" "ac_cv_header_fitsio_h" "$ac_includes_default" @@ -6884,7 +6862,7 @@ # report actual input values of CONFIG_FILES etc. instead of their # values after options handling. ac_log=" -This file was extended by Munipack $as_me 0.5.9, which was +This file was extended by Munipack $as_me 0.5.10, which was generated by GNU Autoconf 2.69. Invocation command line was CONFIG_FILES = $CONFIG_FILES @@ -6951,7 +6929,7 @@ cat >>$CONFIG_STATUS <<_ACEOF || ac_write_fail=1 ac_cs_config="`$as_echo "$ac_configure_args" | sed 's/^ //; s/[\\""\`\$]/\\\\&/g'`" ac_cs_version="\\ -Munipack config.status 0.5.9 +Munipack config.status 0.5.10 configured by $0, generated by GNU Autoconf 2.69, with options \\"\$ac_cs_config\\" diff -Nru munipack-0.5.9/configure.ac munipack-0.5.10/configure.ac --- munipack-0.5.9/configure.ac 2017-07-17 23:03:48.000000000 +0000 +++ munipack-0.5.10/configure.ac 2018-01-16 17:58:03.000000000 +0000 @@ -1,5 +1,5 @@ dnl -dnl Copyright © 1997-2016 F.Hroch (hroch@physics.muni.cz) +dnl Copyright © 1997-2018 F.Hroch (hroch@physics.muni.cz) dnl dnl This file is part of Munipack. dnl @@ -16,17 +16,19 @@ dnl You should have received a copy of the GNU General Public License dnl along with Munipack. If not, see . dnl +dnl * Separate variable for Minpack (to prevent use of LIBS)? +dnl AC_PREREQ([2.69]) -AC_INIT([Munipack],[m4_esyscmd(echo -n $VERSION)],[Filip Hroch ], +AC_INIT([Munipack],[0.5.10],[Filip Hroch ], [munipack],[http://munipack.physics.muni.cz]) dnl define development build -AC_SUBST(develop,[m4_esyscmd(echo -n $DEVELOPMENT)]) -if test "x$develop" = "xyes"; then -AC_DEFINE(DEVELBUILD,[1],[indicates development build]) -AC_DEFINE_UNQUOTED(DATEBUILD,[`date +'"%F %T %Z"'`],[configure time]) -fi +dnl AC_SUBST(develop,[m4_esyscmd(echo -n $DEVELOPMENT)]) +dnl if test "x$develop" = "xyes"; then +dnl AC_DEFINE(DEVELBUILD,[1],[indicates development build]) +dnl AC_DEFINE_UNQUOTED(DATEBUILD,[`date +'"%F %T %Z"'`],[configure time]) +dnl fi AC_CANONICAL_BUILD @@ -58,16 +60,6 @@ dnl AC_SUBST(FC_MODINC,[-I]) dnl AC_SUBST(FC_MODOUT,[-J]) - -dnl additional parameters of compilers/targets -case $build in - *solaris*) - CFITS_LIBS="-lnsl -lsocket" - ;; - *) - ;; -esac - dnl cfitsio AC_CHECK_HEADERS([fitsio.h]) AC_CHECK_LIB([cfitsio], [ffclos],AC_SUBST(LIBCFITSIO,-lcfitsio), diff -Nru munipack-0.5.9/debian/changelog munipack-0.5.10/debian/changelog --- munipack-0.5.9/debian/changelog 2017-08-04 19:13:25.000000000 +0000 +++ munipack-0.5.10/debian/changelog 2018-01-17 18:31:14.000000000 +0000 @@ -1,8 +1,8 @@ -munipack (0.5.9-1build1) artful; urgency=medium +munipack (0.5.10-1) unstable; urgency=low - * No-change rebuild for libgfortran soname change. + * New upstream version, updated debian control files by recent standards. - -- Matthias Klose Fri, 04 Aug 2017 19:13:25 +0000 + -- Filip Hroch Wed, 17 Jan 2018 19:31:14 +0100 munipack (0.5.9-1) unstable; urgency=low diff -Nru munipack-0.5.9/debian/compat munipack-0.5.10/debian/compat --- munipack-0.5.9/debian/compat 2017-07-18 00:11:38.000000000 +0000 +++ munipack-0.5.10/debian/compat 2018-01-17 18:31:14.000000000 +0000 @@ -1 +1 @@ -9 +11 diff -Nru munipack-0.5.9/debian/control munipack-0.5.10/debian/control --- munipack-0.5.9/debian/control 2017-07-18 00:11:38.000000000 +0000 +++ munipack-0.5.10/debian/control 2018-01-17 18:31:14.000000000 +0000 @@ -3,14 +3,14 @@ Priority: optional Maintainer: Debian Astronomy Team Uploaders: Filip Hroch -Build-Depends: debhelper (>= 9), dh-autoreconf, gfortran, g++ (>= 6), libcfitsio-dev, libwxgtk3.0-dev, minpack-dev -Standards-Version: 4.0.0 +Build-Depends: debhelper (>= 11), gfortran, g++ (>= 6), libcfitsio-dev, libwxgtk3.0-dev, minpack-dev +Standards-Version: 4.1.3 Homepage: http://munipack.physics.muni.cz/ Vcs-Git: https://anonscm.debian.org/git/debian-astro/packages/munipack.git Vcs-Browser: https://anonscm.debian.org/cgit/debian-astro/packages/munipack.git Package: munipack -Architecture: any +Architecture: all Depends: munipack-gui, munipack-cli, munipack-doc, ${misc:Depends} Description: Astronomical photometry software package Munipack is a general astronomical photometry software package. @@ -65,7 +65,6 @@ Package: munipack-doc Section: doc Architecture: all -Multi-Arch: foreign Depends: ${misc:Depends} Description: Documentation of Munipack Munipack is a general astronomical photometry software package. diff -Nru munipack-0.5.9/debian/copyright munipack-0.5.10/debian/copyright --- munipack-0.5.9/debian/copyright 2017-07-18 00:11:38.000000000 +0000 +++ munipack-0.5.10/debian/copyright 2018-01-17 18:31:14.000000000 +0000 @@ -4,8 +4,8 @@ Source: http://integral.physics.muni.cz/hg/munipack/ Files: * lib/nelmin.f95 lib/pppack.f90 lib/fmin.f95 -Copyright: (c) 1997-2016 Filip Hroch - 2016 Filip Hroch (Debian files) +Copyright: (c) 1997-2018 Filip Hroch + 2016-8 Filip Hroch (Debian files) (c) 2016 J. Burkardt (nelmin.f95, pppack.f90) (c) 1977, George Elmer Forsythe, Michael A. Malcolm, Cleve B. Moler (fmin by netlib.org) License: GPL-3+ diff -Nru munipack-0.5.9/debian/munipack-doc.doc-base munipack-0.5.10/debian/munipack-doc.doc-base --- munipack-0.5.9/debian/munipack-doc.doc-base 2017-07-18 00:11:38.000000000 +0000 +++ munipack-0.5.10/debian/munipack-doc.doc-base 2018-01-17 18:31:14.000000000 +0000 @@ -1,9 +1,9 @@ Document: munipack-doc Title: Munipack Webpage Author: Filip Hroch -Abstract: A description and usage of munipack together with examples. +Abstract: A description and usage of Munipack together with examples. Section: Science/Astronomy Format: HTML -Index: /usr/share/doc/munipack-doc/munipack.html -Files: /usr/share/doc/munipack-doc/*.html +Index: /usr/share/doc/munipack/munipack.html +Files: /usr/share/doc/munipack/*.html diff -Nru munipack-0.5.9/debian/rules munipack-0.5.10/debian/rules --- munipack-0.5.9/debian/rules 2017-07-18 00:11:38.000000000 +0000 +++ munipack-0.5.10/debian/rules 2018-01-17 18:31:14.000000000 +0000 @@ -9,5 +9,12 @@ # Uncomment this to turn on verbose mode. #export DH_VERBOSE=1 +# Use to prevent less important (underflow/inexact/..) summary reports +# (man dpkg-buildflags). +export DEB_FCFLAGS_MAINT_APPEND = -ffpe-summary=invalid,zero,overflow + %: - dh $@ --with autoreconf + dh $@ --no-parallel + +# A parallel build is disabled to prevent use of unavailable Fortran modules +# (when compilation of a module needs more time than the source itself). diff -Nru munipack-0.5.9/debian/tests/check.sh munipack-0.5.10/debian/tests/check.sh --- munipack-0.5.9/debian/tests/check.sh 2017-07-18 00:11:38.000000000 +0000 +++ munipack-0.5.10/debian/tests/check.sh 2018-01-17 18:31:14.000000000 +0000 @@ -6,7 +6,7 @@ munipack find -f 5 $FILE munipack aphot $FILE -munipack cone -r 0.2 -- 269.5 4.6 +munipack cone -r 0.1 --par 'Vmag=<15' -- 269.44 4.69 munipack astrometry $FILE munipack phcal --photsys-ref Johnson --area 0.3 \ --col-ra RAJ2000 --col-dec DEJ2000 \ diff -Nru munipack-0.5.9/debian/watch munipack-0.5.10/debian/watch --- munipack-0.5.9/debian/watch 2017-07-18 00:11:38.000000000 +0000 +++ munipack-0.5.10/debian/watch 2018-01-17 18:31:14.000000000 +0000 @@ -1,2 +1,2 @@ -version=3 +version=4 ftp://integral.physics.muni.cz/pub/munipack/munipack-(0\.[0-9]+\.[0-9]+)\.tar\.gz debian uupdate diff -Nru munipack-0.5.9/doc/artific.shtml munipack-0.5.10/doc/artific.shtml --- munipack-0.5.9/doc/artific.shtml 2017-07-17 23:03:48.000000000 +0000 +++ munipack-0.5.10/doc/artific.shtml 2018-01-16 17:58:03.000000000 +0000 @@ -10,7 +10,7 @@

Artificial Sky

- Overview of an artificial sky phenomena. + An overview of an artificial sky modelling.

@@ -18,31 +18,23 @@

The tool artificial creates artificial frames which looks - similar as ones which has been acquired by a real telescope. - The primary purpose of this tool is to test and verify processing algorithms - of Munipack. - -

- -

- The artificial sky can be also considered as the powerful framework - -for education and testing purposes because provides - modelling of various observational effects. + similar as frames acquired by a real telescope. The primary purpose of + this tool is to test and to verify algorithms of Munipack. + However, it can be very useful + for both education and planing of an observation + because various atmospheric and instrumental effects as well + as various phenomena can be easy modelled.

Brand Icon

All generated frames are marked by a brand icon. The icon is supposed - as the very important element because the created frames can look very realistic - for inexperienced peoples. In many situations, it can be very difficult - to recognise, even by an objective method, between a real and an artificial - frame. That why there is no way how to remove the icon without a source - code modification. + as the very important element because the created frames can look very + realistic for inexperienced peoples. In many situations, it can be very + difficult to recognise, even by an objective method, + between a real and an artificial frame. That why there is no way how + to remove the icon without a source code modification.

@@ -51,33 +43,34 @@

- FITS headers contains review of parameters used for generation - which tags the right origin of any frame without doubts. Because frames - are sometimes converted to other picture formats such as PNG or JPG, every picture - has also visible watermark. + FITS headers of all files contains review of parameters used for frame + generation. It naturally indicates the right origin of any frame without + doubts. However, frames are sometimes converted to other picture formats + such as PNG or JPG, or examined by non-expers, + so the clearly visible watermark is the proper warning sign.

The Very First Simulation

- As our very first generated frame, we'll select the open star + For our very first generated frame, we'll select the open star cluster NGC 637 (see A Star Chart Tutorial). - The artificial frame can be generated by the sequence of commands: + The artificial frame can be generated by these commands:

 $ munipack cone -o ngc637.fits -r 0.1 -- 25.775 64.03
 $ munipack artificial -c ngc637.fits --rcen 25.775 --dcen 64.03 --verbose
 

- The result is saved as artificial.fits and displayed - on figure below. Many parameters has been leaved on their default values - as lists --verbose switch. - The most important parameters are - the telescope area 1m (cca 1.1m in diameter by default) and the exposure duration + The result is available as artificial.fits and displayed + on figure below. Many parameters has been keep on their default values + as --verbose switch shows. + The most important parameters are the telescope area 1m2 + (cca 1.1m in diameter by default) and the exposure duration 1 second. The stars on the frame has been given by a catalogue (in this case UCAC4) - so a real exposure will offer more deeper look. + so a real exposure can provide more deeper look.

@@ -89,8 +82,8 @@

Size of the generated picture, field of view (or scale) and rotation can be adjusted. Results can be saved to a named file. The following example creates - a mini picture with dimensions in golden ratio, which is rotated about 180° and - saved to ngc637_mini.fits file. + a mini picture with dimensions in golden ratio, which is rotated around + center with 180° angle and stored in ngc637_mini.fits file.

 $ munipack artificial -c ngc637.fits --rcen 25.775 --dcen 64.03 --verbose \
@@ -107,12 +100,13 @@
 

Observation Planning

- Artificial frames can be useful in preparing of a plan of observation. - The proper choice of the exposure for an unknown object significantly - influencing reliability and precision of results. + Artificial frames can be useful in preparing of plans of an observation. + The observer's proper choice of the exposure time for an unknown object + significantly increase both reliability and precision of results. The matter can be generalised also on an unknown telescope, - actual observing conditions, detectors. The artificial sky tool can help - to save precious observing time. + actual observing conditions, detectors. All the conditions can be + adjusted "on the run", but this tool can help to save precious + observing time.

@@ -135,12 +129,12 @@

- Be informed the frames with different parameters can looks identical due - auto-adjusting capabilities of Munipack's viewer. Observed frames taken + Keep in mind, the frames with different parameters can looks identical due + auto-adjusting capabilities of FITS viewers. Observed frames taken at longer exposures will reveal more faint stars, which are not included in common catalogues, due to its limitations. To be sure, while playing with - artificial sky, inspect values of single pixels inside stars, their counts - are proportional to the parameters. + artificial sky, inspect values of single pixels inside stars, that + simulated counts are proportional to the parameters.

@@ -184,8 +178,8 @@ --col-mag which is important here). The error due to photon noise is relative high and longer exposure duration can be recommend. Moreover, - the used quantum efficiency only 2% (!) is extremely low and an technical - improvement in apparatus looks like a very good idea. + the used quantum efficiency only 2% (!) is extremely low and + an technical improvement in apparatus can be recommended.

@@ -194,24 +188,25 @@

Light rays passing Earth's atmosphere are scattered, reflected - and attenuated proportionally to the length its optical path. The - modelled effects includes atmospheric extinction and seeing. + and attenuated proportionally to the length its path in the atmosphere. + The atmosphere related effects, which are modelled, includes + both atmospheric extinction and seeing and sky background dependence. The atmospheric refraction is excluded.

The effects are considered just if --atmosphere switch is presented. Only the extinction parameter (--extk) - is available for adjusting (see manual page). + can be adjusted (see manual page). The proper set up of observation station and time - (--long, --lat, --date, --time ) should be specified. + (--long, --lat, --date, --time ) is necessary.

- We will prepare of a sequence of seven frames, each 1 s, - separated by one hour interval and modelling BL Lac blazar field - during its down somewhere in central Europe. The figure below shows - selected resulting frames. + To show the capability, we will prepare of a sequence of seven frames, + each 1 s, separated by one hour interval which demonstrate atmospheric + effects on BL Lac blazar field during its down somewhere in central Europe. + The figure below shows two selected output frames.

 $ munipack cone -r 0.2 -- 330.68 42.27
@@ -246,11 +241,19 @@
 The radius represents spreading of a star image by turbulent motions
 in Earth atmosphere. The turbulence is very unpredictable. The fact
 is known to observers at moments when "focusing is impossible".
+It also confirms the experience that the best focusing is near zenith.
 

Light Curves

+ Light curves extracted from generated frames can be used for + training purposes as well as testing of various processing algorithms. +

+ +

+ There are more ways to specify a light curve. + We will select the most common way. The light curve pattern can be included in a table with twines: time, magnitude (detailed description by Times series document). The table is used to create a required light curve. @@ -271,8 +274,7 @@

The first step is preparation of the data to form (FITS file) required by the utility. The easy way is modification - of Kepler-21b.lst file. The table is included - near the end: + of Kepler-21b.lst file:

 0 1.00714
@@ -282,9 +284,9 @@
 ....
 

- The data can be replaced any another set. The number of rows must be - corresponds with NAXIS2 keyword. When the file is prepared create - FITS table (note that FITS table can be created also any any other way): + The data can be replaced any another set. The number of rows must + corresponds with NAXIS2 keyword. When the file is prepared, create + FITS table (note that FITS table can be also created by any other way):

 $ munipack fits --restore Kepler-21b.lst
@@ -319,11 +321,11 @@
 
 

The artificial frames can be processed by the same way how frames - which has been taken on the real sky. The processing steps + which has been taken on the real sky. The processing skips photometric corrections (like bias frames) and the astrometry calibration which is already included. There is no - photometry catalogue, so I referenced all frames onto the first (by random - choice) frame in sequence. There is the processing sequence: + photometry catalogue, so I referenced all frames against the first + (by random choice) frame in sequence. There are the processing steps:

 $ munipack find art_??.fits
@@ -335,7 +337,7 @@
 
 
Kepler-21b.svg -
Artificial light curve and model of Kepler-21b.
+
The artificial light curve and the model of Kepler-21b.
diff -Nru munipack-0.5.9/doc/cbasic.shtml munipack-0.5.10/doc/cbasic.shtml --- munipack-0.5.9/doc/cbasic.shtml 2017-07-17 23:03:48.000000000 +0000 +++ munipack-0.5.10/doc/cbasic.shtml 1970-01-01 00:00:00.000000000 +0000 @@ -1,144 +0,0 @@ - - - - -Munipack ‒ Basics usage - - - - -
-

Munipack ‒ Basic Usage (Classics Edition)

- -

-Munipack offers a set of computer routines as tools for various -kinds of astronomical photometry. -

- -

-All utilities are prepared as independent software tools, -whereas every utility is intended to done only one task. -All operations will be done without any interaction with user -during run, so it is suitable for running of extensive -batch processing. It is supposed that the utilities will be combined -in a concrete way to done some specific processing. -

- -

-From the practical point of view, Munipack offers set of shell -utilities which uses standard input, switches and standard output -as in the same manner as all other tools in system. Both input and -output interaction is implemented via plain text or FITS files providing -easy way to modify and use of results of computation. Every shell -utility can be replaced by an another one to better fit of a solved -problem. That, Munipack's routines may be a base for a derived -package. -

- - -

Command line interface

- -

-The core of Munipack is a set of utilities which are listed -in the following table: -

- - - - - - - - - - - - -
UtilityPurpose
muniphotBackground estimation, automatic -search for stars, aperture photometry.
munimatchEstimation of shift, scale and rotation - between images
kombineSum (an combination) of images.
munilistList of magnitudes, differential magnitudes, etc. - from a set of images.
mdark(Robust) mean of images (masterdark, masterbias).
aflatAuto-flat-field as robust mean with running scaling (masterflat).
flatbatA set of scientific exposures is divided by a flat-field.
darkbatA set of scientific exposures is subtracted by a dark or bias.
konveA (unmaintained) converter from SBIG's ST files to FITS.
pickoA (unmaintained) converter from Chr. Buil's PIC files to FITS.
- -

-Some external utilities can be used -as additional tools. -

- - -

-All routines are used in a common way. If we will run any utility -without parameters, some on-line help will print: -

-
-DARKBAT Version 1.9, Copyright (C) 1997-08 F.Hroch, Masaryk University,Brno,CZ
-
-DARKBAT   Utility for the dark frame subtract.
-
-Usage:darkbat [options] [@dirfile] [dark=darkframe] [mask=?] [image1] ...
-
-@dirfile= file with image names for dark subtract, no wildcards *,?
-          (use only '@' to read image names from standard input)
-dark= dark frame image
-image1...= name(s) of simple image(s) to dark subtract
-bitpix=[8,16,-32] set bitpix of output to specified value
-mask= output mask (default = dout????.fits)
-      give 'mask=.' for overwrite input files (carefully!)
-      give 'mask=$' for copy files with original basename to current dir
-
-options:
-	-d <darkname>	 dark frame image (equivalent with 'dark=')
-	-o <mask>	 output mask (equivalent with 'mask=')
-	-c <number>	 counter initial value (default = 1)
-	-h	 give this help
-	-L	 display software license
-
- -

-There is a common way of usage of all command-line utilities. -Every utility reads names of files to process (mostly FITS images) -from standard input, setup some parameters by command switches, done -a processing and save output to (mostly) FITS images. These images can be -processed again by another tools or any another utilities. -

- -

-The parameters of command switches are usually specified as strings -in format par=<value> and user is resposible to specify -its value. To setup of reading of standard input, the switch @ -is used. Note that the used syntax is Iraf-like. -

- - -

-As common example, we had choose subtraction of a dark frame -from a set of scientific exposures. If we have a dark frame in -FITS file darkframe.fits and scientific exposures -in m666_1R.fits, m666_2R.fits, the dark frame can be -subtracted with the command: -

-
- sh$ ls m666_1R.fits, m666_2R.fits | darkbat @ dark=darkframe.fits
-
-

The corrected images will available as dout0001.fits -and dout0002.fits. The filename can be changed by -parameter mask=. For example, the command -

- sh$ ls m666_1R.fits, m666_2R.fits | darkbat @ dark=darkframe.fits mask=m666_?Rd.fits
-
-

-will save images to m666_1Rd.fits and m666_2Rd.fits. -Usually, observed non-processsed data are archived in a directory (with read -only access) and we are working in another directory, commonly -named as working directory. That, we can use another form of mask= -option which will be save processed images to current working directory -with the same filename: -

- sh$ ls m666_1R.fits, m666_2R.fits | darkbat @ dark=darkframe.fits mask=$
-
- -
- - - - - diff -Nru munipack-0.5.9/doc/changes.shtml munipack-0.5.10/doc/changes.shtml --- munipack-0.5.9/doc/changes.shtml 2017-07-17 23:03:48.000000000 +0000 +++ munipack-0.5.10/doc/changes.shtml 2018-01-16 17:58:03.000000000 +0000 @@ -10,6 +10,37 @@

Summary of recent development.

+

Changelog of 0.5.10 (Flat-fielding) release

+ +

Release date: 16. January, 2018.

+

This release is focused on improving of already + developed features.

+ +

Improvements:

+
    +
  • Developed new flat-field approach which is mostly like + onto photometry calibration than a plain averaging. + I believes the implementation is correct, from different + points of view, for the first time.
  • +
  • Astrometry has faster lucky-match option, input stars are + sliced by brightness, has enhanced robust algorithms (estimate + of scale, stability, reliability) and some bug-fixes.
  • +
  • Estimation of the photometry calibration is regularised which + leads to more precise and reliable results of photometry, + flat-fielding, etc.
  • +
  • Kombine implements averaging of input frames and the + result frames might be rotated.
  • +
  • Improved estimation of std.errors for aperture photometry + leading to better photometric precision as well as conversion + of some photometric quantities.
  • +
  • All robust algorithms has updated their estimate of scale.
  • +
  • Improved artificial features: background in magnitudes per + square arcsecond, documentation. +
  • Bug-fixes in utilities: phcorr, artificial, votable, list and + the graphical interface.
  • +
+ +

Changelog of 0.5.9 (Artificial Sky) release

Release date: 18. July, 2017.

@@ -29,7 +60,8 @@

Improvements:

    -
  • Robust statistical methods are implemented by more reliable algorithms.
  • +
  • Robust statistical methods are implemented by more reliable + algorithms.
  • Flat-fielding problem is fully solved.
  • Added UCAC5 catalogue. UCAC4 is still default due wider (photometry) completness.
  • diff -Nru munipack-0.5.9/doc/classics.shtml munipack-0.5.10/doc/classics.shtml --- munipack-0.5.9/doc/classics.shtml 2017-07-17 23:03:48.000000000 +0000 +++ munipack-0.5.10/doc/classics.shtml 2018-01-16 17:58:03.000000000 +0000 @@ -1,6 +1,6 @@ - + - + Munipack - Classics Edition @@ -14,8 +14,8 @@

    -The classics edition of Munipack is a set of command-line utilities -without a graphical user interface and an unified command line interface. +The classics edition of Munipack was a set of command-line utilities +without a graphical user interface and an unified command line interface. One was developed at end of last century (1997 - 2000) and maintained up to 2008.

    @@ -23,11 +23,11 @@

    Munipack has been originally developed on base of P.B.Stetson's DAOPHOT II -packaged in ESO +packaged in ESO Midas distribution. The classic version shares many great ideas of the original Daophot II and adds -a lot of enhancements. The additional code contains photometry reduction, +a lot of enhancements. The additional code contains photometry reduction, astrometry, image matching and combining utilities.

    @@ -36,16 +36,6 @@ (and offers much more over) of the classic edition.

    -

    Documentation

    - -

    -Tutorial – How to create a light curve with Munipack. -

    - -

    -Basic – A basic info about Munipack. -

    -

    Download

    diff -Nru munipack-0.5.9/doc/colorcal.shtml munipack-0.5.10/doc/colorcal.shtml --- munipack-0.5.9/doc/colorcal.shtml 2017-07-17 23:03:48.000000000 +0000 +++ munipack-0.5.10/doc/colorcal.shtml 2018-01-16 17:58:03.000000000 +0000 @@ -10,7 +10,7 @@

    Color Calibration of an Instrumental Photometric System

    -How to calibrate of an instrumental photometric system. +How to calibrate of an instrumental photometric system.

    Open cluster M 67

    @@ -21,8 +21,8 @@

    -As the calibration stars, we are choose data -which has been carefully measured by Arne Henden +As the calibration stars, we are choose data +which has been carefully measured by Arne Henden (M67 Standards Field).

    @@ -30,8 +30,8 @@

    Sample Data

    -A sample data are available as -munipack-data-m67.tar.gz. Use commands +A sample data are available as +munipack-data-m67.tar.gz. Use commands

     $ cd /tmp
    @@ -57,7 +57,7 @@
     
     

    General relations can by derived as an approximation -of a set of functions (instrumental filters) by another +of a set of functions (instrumental filters) by another set functions (standard filters) as a linear transformations. A simple example is the calibration of instrumental v-filter by a standard V-filter: @@ -66,7 +66,7 @@ v - V = a + b*(V-R)

    -The goal is to determine coefficients a,b by a fit +The goal is to determine coefficients a,b by a fit of a linear function. The precision depends on coverage of color index V-R and that is why we use the evolved cluster.

    @@ -79,7 +79,7 @@

      -
    1. Prepare images for photometric corrections as describes +
    2. Prepare images for photometric corrections as describes Photometric Corrections Tutorial.
    3. Stars detection and photometry
      @@ -107,7 +107,6 @@
       
    4. Aperture photometry of final frames
       $ munipack aphot -f 6 M67_Blue.fits M67_Green.fits
      -
       
    5. @@ -115,15 +114,7 @@
       $ munipack phframe --table -q IMAG --naperture 7 M67_Green.fits,M67_Green_res.fits
       $ munipack phframe --table -q IMAG --naperture 7 M67_Blue.fits,M67_Blue_res.fits
      -
      -

      The file M67_Green_res.fits contains the table:

      diff -Nru munipack-0.5.9/doc/colorimage.shtml munipack-0.5.10/doc/colorimage.shtml --- munipack-0.5.9/doc/colorimage.shtml 2017-07-17 23:03:48.000000000 +0000 +++ munipack-0.5.10/doc/colorimage.shtml 2018-01-16 17:58:03.000000000 +0000 @@ -16,7 +16,7 @@

      Dumbbell Nebula In Colours

      -Dumbbell nebula (M 27) is a planetary nebula in Saggita. Dumbbell is +Dumbbell nebula (M 27) is a planetary nebula in Saggita. Dumbbell is one from favourite objects for small telescopes, although its colours are unseen for visual observers except very large equipment.

      @@ -25,7 +25,7 @@

      Sample Data

      -A sample data are available as +A sample data are available as munipack-data-m27.tar.gz. Save it to arbitrary directory (for example /tmp/) like:

      @@ -37,7 +37,7 @@

      The directory munipack-data-m27/ contains exposures in the instrumental colour system (nearly Johnson) in BVR filters and corresponding dark frames. -B filter exposures has duration 60 seconds. Both V and R filter exposures has +B filter exposures has duration 60 seconds. Both V and R filter exposures has 40 seconds. Flat-fields are not available.

      @@ -71,7 +71,7 @@ (required for astrometric calibration) in Virtual Observatory and stores results of search in file cone.fits:
      -$ munipack cone -r 0.1 299.87 22.71
      +$ munipack cone -r 0.1 --  299.87 22.71
       
    6. Prepare the astrometric calibration of images (wait a while) @@ -99,7 +99,7 @@
    7. Result is the colour image
      -$ munipack coloring -c 'Johnson BVR' -o m27.fits m27_B.fits m27_V.fits m27_R.fits 
      +$ munipack coloring -c 'Johnson BVR' -o m27.fits m27_B.fits m27_V.fits m27_R.fits
       
    @@ -124,16 +124,17 @@

    The output image nicely shows regions where radiation of forbidden lines dominates -(green) and Hα regions heated by shock-waves (red). +(green) and Hα regions heated by shock-waves (red).

    -Also try how this image would be visible by human vision at night, when colour vision +Also try how this image would be visible by human vision at night, when colour vision receptors (rods) is not activated. The appearance will be similar to visual sights. Use xmunipack and Tune->Color_menu or try helper utility:

    -$ fitspng -fn 0,1 -o m27.png m27.fits
    +$ munipack ctrafo -o m27_xyz.fits -c 'XYZ' m27.fits 1e4,0.66 24e3,1 52e3,1
    +$ fitspng -fl 0,3e4 -o m27.png m27_xyz.fits
     

    See Also

    @@ -148,8 +149,9 @@

    -Tutorial: -Image Compositions +Tutorial: +Image Compositions and +the shell script m27.sh.

    diff -Nru munipack-0.5.9/doc/colorspace.shtml munipack-0.5.10/doc/colorspace.shtml --- munipack-0.5.9/doc/colorspace.shtml 2017-07-17 23:03:48.000000000 +0000 +++ munipack-0.5.10/doc/colorspace.shtml 2018-01-16 17:58:03.000000000 +0000 @@ -162,7 +162,7 @@
    - +
    The image has strong orange background due to sodium lamps. One has been taken @@ -311,7 +311,7 @@
    - +
    @@ -391,7 +391,7 @@
    - +
    @@ -490,7 +490,7 @@
    File → Create → Color image.
    - +

    Command line usage

    diff -Nru munipack-0.5.9/doc/ctutorial.shtml munipack-0.5.10/doc/ctutorial.shtml --- munipack-0.5.9/doc/ctutorial.shtml 2017-07-17 23:03:48.000000000 +0000 +++ munipack-0.5.10/doc/ctutorial.shtml 1970-01-01 00:00:00.000000000 +0000 @@ -1,259 +0,0 @@ - - - - -Munipack ‒ Tutorial - - - - -
    -

    Munipack ‒ Tutorial (Classics Edition)

    - -

    -There are presented examples of a simple runs of Munipack's routines. -A first example shows a long time photometry set and the second one -is dedicated to a deep sky object (passed). -

    -

    -A sample data for both runs are available as -munitut-blazar.tar.gz and -munitut-bubble.tar.gz. -Use command tar zxf munitut-blazar.tar.gz and -tar zxf munitut-blazar.tar.gz to unpack it to a current directory. -We will assume that the sample data are unpacked to /tmp directory -as /tmp/munitut-blazar and /tmp/munitut-bubble. -

    - -

    Light curve of blazar 0716+714

    - -

    -We have a set of images, flat-fields and dark-frames for the images. -Our goal is to get a light curve (a time dependence of magnitude) -of the blazar. The same approach -can be used for any object as a variable star, an exoplanet, etc. -

    - - - - - - - -
    FilemaskDescriptionExposure time
    0716_[1-9]R.fitsscientific images120 sec
    d120_[1-7].fitsdark-frames of scientific images120 sec
    f10_[1-9]R.fitsflat-fields10 sec
    d10_[1-9].fitsdark-frames of flat-fields10 sec
    - - -

    Working directory

    - -

    -As a first important step, we will create a working directory. For example, -create /tmp/munitut by the command: -

    -
    -bash$ mkdir /tmp/munitut
    -bash$ cd /tmp/munitut
    -
    -

    -The name of the directory is arbitrary. It is highly recommended to use -any empty directory to prevent unwanted replacement of any data -(especially of original images!). -

    - -

    Mean of dark-frames

    -

    -We will create a mean-dark for scientific exposures. Run the command -

    -
    -bash$ ls /tmp/munitut-blazar/d120_*.fits | mdark @ robust=y mask=d120.fits
    -
    -

    -The asterisk marks all images begins with d120_ -together with a suffix .fits. The command ls lists -images throughout a pipe | to mdark utility which is -set by @ to read image names from its standard input. -The mdark uses robust method of mean estimation and the -mean itself is stored as d120.fits. -

    - -

    -The parameter robust=y is optional, but highly recommended. -It reduces of fluency of cosmic-rays and one-image defects. On the -other side, it requires more computer resources. -

    - -

    -In principle, this step can be omitted, but it is a good practice from -a statistical point of view. The output image is frequently called -as the master-dark. -

    - -
    -d10_1.png -
    -A randomly selected dark image. -
    -
    - -
    -d120.png -
    -Mean of dark-frames (master-dark). -
    -
    - -

    Dark correction

    -

    -Original scientific images can be corrected for dark-frames by -

    -
    -bash$ ls /tmp/munitut-blazar/0716_*R.fits | darkbat @ dark=d120.fits mask=$
    -
    -

    -darkbat subtracts, the previously created mean-dark d120.fits, -from every scientific exposure and produces new images stored in the current -working directory with image names identical to original ones. -

    - -
    -0716_original.png -
    -A randomly selected scientific exposure of blazar 0716+714. -
    -
    - -
    -0716_dark.png -
    -A randomly selected scientific exposure of blazar 0716+714 with the d120 dark-frame subtracted. -
    -
    - - -

    Running mean of flats

    -

    -There is a tree step procedure for creating of the running mean of flats -

    -
    -bash$ ls /tmp/munitut-blazar/d10_*.fits | mdark @ robust=y mask=d10.fits
    -bash$ ls /tmp/munitut-blazar/f10_*R.fits | darkbat @ dark=d10.fits mask=$
    -bash$ ls f10_*R.fits | aflat @ mask=autoflat.fits
    -
    -

    -The first two lines are a modification of our previously described examples -(The original flat-field images are corrected about their mean-dark and -stored in the current directory.) Let's look on tree line. The corrected -flat-fields are scaled by its mean intensity and its dispersion to -a unified output level. A robust mean is made on the uniform scaled flats -and an output flat is stored as autoflat.fits. The output image is -frequently called as the master-flat. -

    - -

    -The key feature of aflat is the scaling and a robust mean of single -flats. The procedure is pretty effective for short series of the twilight -sky's exposures when brightness rapidly decrease. Also, a long over-night series -of non-identical fields (like many blazar fields) will produce excellent -results. -

    - -
    -f10_1.png -
    -A randomly selected flat-field image. -
    -
    - -
    -autoflat.png -
    -A scaled robust mean of flat-fields (master-flat). -
    -
    - - -

    Flat-field correction

    -

    -In analogy of dark correction, scientific images (subtracted for dark) -can be corrected for flats by -

    -
    -bash$ ls 0716_*R.fits | flatbat @ flat=autoflat.fits mask=.
    -
    -

    -We can see that the current directory images are used. With -parameter mask=. the input images are replaced. It may -be potentially dangerous! -

    - -
    -0716_final.png -
    -A randomly selected, fully corrected (dark and flat), image of blazar 0716+714. -
    -
    - - -

    Photometry

    -

    -We can apply an aperture photometry on prepared images: -

    -
    -bash$ qmphot.pl -i 0716_*R.fits
    -bash$ ls 0716_*R.fits | muniphot @ com=.
    -
    -

    -The qmphot.pl prepares configuration files and a running script -to muniphot. -The photometry itself can be executed via generated shell script or -by hand as the second line shows. The run will produce of some additional -files. -

    - -

    -The routine detect all stars on images and made their aperture photometry. -

    - - -

    Matching

    -

    -Matching of images, or matching of list of stars on images, will done with -

    -
    -bash$ ls 0716_*R.SRT | munimatch @ ref=0716_1R.SRT
    -
    -

    -Take note on type of used files. There are not images, but a sorted -list of detected stars .SRT. The reference image has been choose -by random selection to 0716_1R.SRT. -

    - -

    -It is recommended to use nicer images as a reference frame. The routine -derives linear transformations between single images. -

    - -

    List of magnitudes

    -

    -On finish, find coordinates of in inspected object together with a reference -(comparison) star and run -

    -
    -bash$ ls 0716_*R.fits | munilist @ 256,156 258,88 > lc
    -
    -

    -The text file lc contains our measured light curve. The table with -Julian times and relative magnitudes (together with estimation of residuals). -

    - -
    -lc0716.png -
    -Output light curve -
    -
    - -
    - - - - diff -Nru munipack-0.5.9/doc/dataform_proc.shtml munipack-0.5.10/doc/dataform_proc.shtml --- munipack-0.5.9/doc/dataform_proc.shtml 2017-07-17 23:03:48.000000000 +0000 +++ munipack-0.5.10/doc/dataform_proc.shtml 2018-01-16 17:58:03.000000000 +0000 @@ -195,8 +195,8 @@ Keywords KeywordUnitsDescription EXTNAMEGROWCURVE as the identifier of this table -HWHMHWHM estimated by growth curve in pixelspix -RADFLX90Radius containing 90% of energypix +HWHMpixHWHM estimated by growth curve in pixels +RADFLX90pixRadius containing 90% of energy

    Table

    diff -Nru munipack-0.5.9/doc/debbuilder.shtml munipack-0.5.10/doc/debbuilder.shtml --- munipack-0.5.9/doc/debbuilder.shtml 2017-07-17 23:03:48.000000000 +0000 +++ munipack-0.5.10/doc/debbuilder.shtml 2018-01-16 17:58:03.000000000 +0000 @@ -101,7 +101,7 @@

    All the required, or any missing, utilities can be installed as:

    -
    # apt-get install gfortran g++ libwxgtk3.0-dev libcfitsio3-dev debhelper dh-autoreconf, minpack-dev
    +
    # apt-get install gfortran g++ libwxgtk3.0-dev libcfitsio-dev debhelper dh-autoreconf minpack-dev
     

    Build of DEB Packages

    diff -Nru munipack-0.5.9/doc/docs.shtml munipack-0.5.10/doc/docs.shtml --- munipack-0.5.9/doc/docs.shtml 2017-07-17 23:03:48.000000000 +0000 +++ munipack-0.5.10/doc/docs.shtml 2018-01-16 17:58:03.000000000 +0000 @@ -3,7 +3,7 @@ - diff -Nru munipack-0.5.9/doc/flatdebug_3.svg munipack-0.5.10/doc/flatdebug_3.svg --- munipack-0.5.9/doc/flatdebug_3.svg 1970-01-01 00:00:00.000000000 +0000 +++ munipack-0.5.10/doc/flatdebug_3.svg 2018-01-16 17:58:03.000000000 +0000 @@ -0,0 +1,178 @@ + + + + +Gnuplot +Produced by GNUPLOT 5.0 patchlevel 5 + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + 0 + + + + + 5000 + + + + + 10000 + + + + + 15000 + + + + + 20000 + + + + + 25000 + + + + + -5 + + + + + -4 + + + + + -3 + + + + + -2 + + + + + -1 + + + + + 0 + + + + + 1 + + + + + 2 + + + + + 3 + + + + + 4 + + + + + 5 + + + + + + + + + number of values + + + + + normalised residual + + + + + 'flatdebug_3.dat' using (bin($2,binwidth)):(1.0) + + + + 21e3*exp(-x**2/2/1**2) + + + + + + + + + + + + + + + + diff -Nru munipack-0.5.9/doc/flatdebug_zero.svg munipack-0.5.10/doc/flatdebug_zero.svg --- munipack-0.5.9/doc/flatdebug_zero.svg 1970-01-01 00:00:00.000000000 +0000 +++ munipack-0.5.10/doc/flatdebug_zero.svg 2018-01-16 17:58:03.000000000 +0000 @@ -0,0 +1,147 @@ + + + + +Gnuplot +Produced by GNUPLOT 5.0 patchlevel 5 + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + 0 + + + + + 10000 + + + + + 20000 + + + + + 30000 + + + + + 40000 + + + + + 50000 + + + + + 60000 + + + + + 0.97 + + + + + 0.98 + + + + + 0.99 + + + + + 1 + + + + + 1.01 + + + + + 1.02 + + + + + 1.03 + + + + + + + + + number of values + + + + + flat-field value + + + + + 'flatdebug_zero.dat' using (bin($3,binwidth)):(1.0) + + + + + + + + + + + + + + + + Binary files /tmp/tmpIsR5ah/LGkvHlXPpo/munipack-0.5.9/doc/flatfielding.png and /tmp/tmpIsR5ah/a0pF0kjEWv/munipack-0.5.10/doc/flatfielding.png differ diff -Nru munipack-0.5.9/doc/flatfielding.shtml munipack-0.5.10/doc/flatfielding.shtml --- munipack-0.5.9/doc/flatfielding.shtml 1970-01-01 00:00:00.000000000 +0000 +++ munipack-0.5.10/doc/flatfielding.shtml 2018-01-16 17:58:03.000000000 +0000 @@ -0,0 +1,211 @@ + + + + +Munipack ‒ Flat-field + + + + +

    Flat-field

    + +

    + Overview of a general flat-fielding problem and description + of its solution by Munipack. +

    +

    + Munipack implements its own flat-field algorithm on base of + the standard photometry calibration rather than commonly used + methods (they uses of median of scaled flat-fields). + The presented approach enables to reach the maximal possible + precision which is limited by only statistical noise of light. + The approach is unique and has been not found + in any available literature. +

    + +

    Standing on the shoulders of flat-fields

    + +

    + Although a correct flat-field is the crucial tool for reaching + suitable photometry precision of observations, the care of acquiring + and processing of flat-fields is not appropriate. This is + especially true for any flat-field post-processing. +

    + +

    + A capacity of common semi-conductor detectors is limited + on values, say, 100k counts per pixels. + A good flat-field has its + mean level about 50k counts which gives its relative precision on value + √50k / 50k ≈ 0.004 per pixel, if Poisson distribution can by considered. + So for a star which occupy about + ten pixels (3×3), one will have a relative precision over 0.01 magnitude + due to the flat-field. A small error in flat-field determination + leads to measurable deviations of results. +

    + +

    + To improve the precision, some increase of a capacity of detectors + can help, but it have technical limitations. Also, it will not suppress + different light sensitivity of pixels including all the optical path. + In this case, the feasible way is averaging of frames as provides + Munipack flat utility. +

    + + +

    The flat-fielding mystery revealing

    +

    + Mean levels of flat-fields, captured using of an unstable light source + (during twilight), are unequal. + As a consequence, a direct average of that flat-fields + is impossible. +

    +

    + A common solution of the trouble is normalisation of flat-fields + on an unique intensity level preparatory to an averaging. + The problem of the + approach is determination of a mean level of every frame. + Its values has no + Normal + distribution + which is leading to a poor definition of the average level. +

    + + + +
    + + + + + +
    + inital flat + + Histogram +
    +
    + A distribution of values of flat-field shows an asymmetric histogram +
    +
    + +

    + The main difficulty comes due to the folded surface of flat-fields. + While it is possible to compute a mean level, the estimate + will not be optimal or accurate due to blending of statistical + distributions: the light noise and the surface of flat-field + itself. +

    + +

    + The crucial point of Munipack approach is decomposition + of flat-field frames on single, independent pixels. + These pixels, with the same position but collected + over all frames, can be considered as sources of light + like stars and similar procedure as the star calibration can be used. + Reference sources are initially unknown, + but can be estimated by iterations. +

    + +
    + wrinkled flat +
    + A blended distribution of values as result of a folded surface + of a flat-field +
    +
    + + +

    + Munipack is using two-phase algorithm which determine a rough + flat-field during the first phase (equivalent to common + practice). The second phase determines + the mean level against to the rough flat followed by averaging. + The approach makes the second phase to be work with Normally + distributed data giving precise and reliable results. +

    + + +
    + + + + + +
    +final flat + + Histogram +
    + +
    + The final flat-field accepting folded (wrinkled) property. Resultant + histogram of residuals of an single frame is near Normal distribution + (only on per frame basis deviations). +
    + +
    + +

    + The developed algorithm solves a non-linear implicit equation + for both levels and all pixels of the resultan flat-field. + The approach is a variant of photon calibration where + the reference photon sources are iterative established + during the computation. +

    + + +

    Flat-fielding rules

    + +

    + There is a list of rules, + summarising of my long time experiences with flat-fielding, + which I recommends for flat-fielding: +

    +
      +
    • The flat-field frame is very important, because + a quality of the flat-field determines photometry precision + of results.
    • +
    • Only twilight flat-frames are acceptable (any light gadgets + gives only poor results – please send me counter-example).
    • +
    • The twilight flats can be acquired with this rules in mind: +
        +
      • acquire only on clear sky without any clouds,
      • +
      • additional light pollution by an artificial light or Moon is + unacceptable,
      • +
      • use opposite directions on Sun,
      • +
      • choose fields in Earth's shadow,
      • +
      • acquire on field not too close to horizon,
      • +
      • keep polarisation + due to Sun on minimum, +
      • +
      • select a field with sparse and faint stars,
      • +
      • switch-off sidereal motion of telescope mount's,
      • +
      • use shorter minimal exposure to prevent changes of illumination + during the twilight (but not such short to capture + shutter speed),
      • +
      • prefer levels of flat-fields around half of its full range (capacity). +
      +
    • +
    + + +

    See Also

    + +

    +Flat-field manual, +Photometry corrections. +Standing on the shoulders of giants. +

    + + + + Binary files /tmp/tmpIsR5ah/LGkvHlXPpo/munipack-0.5.9/doc/flatfine.png and /tmp/tmpIsR5ah/a0pF0kjEWv/munipack-0.5.10/doc/flatfine.png differ Binary files /tmp/tmpIsR5ah/LGkvHlXPpo/munipack-0.5.9/doc/flatzero.png and /tmp/tmpIsR5ah/a0pF0kjEWv/munipack-0.5.10/doc/flatzero.png differ diff -Nru munipack-0.5.9/doc/foot.shtml munipack-0.5.10/doc/foot.shtml --- munipack-0.5.9/doc/foot.shtml 2017-07-17 23:03:48.000000000 +0000 +++ munipack-0.5.10/doc/foot.shtml 2018-01-16 17:58:03.000000000 +0000 @@ -1,6 +1,6 @@

Astronomical Tutorials

@@ -79,22 +80,22 @@
  • Averaged bias frame
  • Averaged dark frame
  • Averaged flat-field frame
  • -
  • Photometric pre-corrections
  • +
  • Photomety corrections
  • Processing
  • Products
  • @@ -104,7 +105,7 @@
  • Color-space transformations
  • -
  • Virtual Observatory +
  • Virtual observatory diff -Nru munipack-0.5.9/doc/head.shtml munipack-0.5.10/doc/head.shtml --- munipack-0.5.9/doc/head.shtml 2017-07-17 23:03:48.000000000 +0000 +++ munipack-0.5.10/doc/head.shtml 2018-01-16 17:58:03.000000000 +0000 @@ -7,7 +7,7 @@ diff -Nru munipack-0.5.9/doc/image_list.mk munipack-0.5.10/doc/image_list.mk --- munipack-0.5.9/doc/image_list.mk 2017-07-17 23:04:23.000000000 +0000 +++ munipack-0.5.10/doc/image_list.mk 2018-01-16 17:58:08.000000000 +0000 @@ -69,6 +69,9 @@ favicon-gprofile.png \ favicon.png \ fedora_icon.png \ + flatfielding.png \ + flatfine.png \ + flatzero.png \ gphoto.png \ gplv3-127x51.png \ gplv3-88x31.png \ @@ -125,9 +128,12 @@ ngc637_mini.jpeg \ Kepler-21b.svg \ comp0716_V.svg \ + flatdebug_3.svg \ + flatdebug_zero.svg \ grow_curve.svg \ grow_curve_anotated.svg \ lc0716_V.svg \ lcapprox.svg \ ngc637.svg \ - res_fill.svg + res_fill.svg \ + wrinkledflat.svg diff -Nru munipack-0.5.9/doc/install.shtml munipack-0.5.10/doc/install.shtml --- munipack-0.5.9/doc/install.shtml 2017-07-17 23:03:48.000000000 +0000 +++ munipack-0.5.10/doc/install.shtml 2018-01-16 17:58:03.000000000 +0000 @@ -35,7 +35,7 @@

    -

    Ubuntu 16.04 (Xenial Xerus)

    +

    Ubuntu 16.04 (Xenial Xerus) and 14.04 (Trusty Tahr)

    ubuntu icon @@ -43,26 +43,34 @@

    There are temporary packages prepared for older Ubuntu (the most frequent - platform). The installation under Ubuntu 16.04 (Xenial Xerus) requires - appending of the following line to + platform) distribution. The installation under Ubuntu 16.04 (Xenial Xerus) + or 14.04 (Trusty Tahr) requires appending of the following line to /etc/apt/sources.list:

    -deb http://munipack.physics.muni.cz/ubuntu/ xenial/
    +deb http://munipack.physics.muni.cz/ubuntu/xenial xenial main
    +
    +

    or

    +
    +deb http://munipack.physics.muni.cz/ubuntu/trusty trusty main
     

    - The system package list should be updated and than Munipack can be installed: + The system package list should to import sign key, be updated and + than Munipack can be installed:

    +$ wget -O - http://integral.physics.muni.cz/~hroch/hroch@physics.muni.cz.gpg.key | \
    +  sudo apt-key add -
     $ sudo apt-get update
     $ sudo apt-get install munipack
     
    +

    Development Repository for Debian

    @@ -89,7 +97,8 @@ and importing GPG key:

    -$ wget -O - http://integral.physics.muni.cz/~hroch/hroch@physics.muni.cz.gpg.key | sudo apt-key add -
    +$ wget -O - http://integral.physics.muni.cz/~hroch/hroch@physics.muni.cz.gpg.key| \
    +  sudo apt-key add -
     

    The installation itself is straightforward: diff -Nru munipack-0.5.9/doc/itone.shtml munipack-0.5.10/doc/itone.shtml --- munipack-0.5.9/doc/itone.shtml 2017-07-17 23:03:48.000000000 +0000 +++ munipack-0.5.10/doc/itone.shtml 2018-01-16 17:58:03.000000000 +0000 @@ -295,7 +295,7 @@

    -controls +controls

    The algorithm

    diff -Nru munipack-0.5.9/doc/lctut.sh munipack-0.5.10/doc/lctut.sh --- munipack-0.5.9/doc/lctut.sh 2017-07-17 23:03:48.000000000 +0000 +++ munipack-0.5.10/doc/lctut.sh 2018-01-16 17:58:03.000000000 +0000 @@ -31,7 +31,7 @@ # astrometry calibration munipack cone -c UCAC5 -r 0.2 -- 110.5 71.3 -munipack astrometry --maxmatch 20 -c cone.fits 0716_*.fits +munipack astrometry -c 'cone.fits[1][$f.mag$>11.and.$f.mag$<15]' 0716_*.fits # photometry calibration wget http://munipack.physics.muni.cz/0716+71.lst @@ -40,12 +40,27 @@ munipack cone -c UCAC4 -o cone_ucac4.fits -r 0.2 -- 110.5 71.3 python ucac_jmuc.py cone_ucac4.fits cone_Johnson.fits +#SAPER="--saper 5" +#THRESH="-th 0.1 -e 0.01" +for FILTER in V R; do + #munipack kombine --average -o 0716.${FILTER}.fits 0716_04?${FILTER}.fits + cp 0716_042${FILTER}.fits 0716.${FILTER}.fits + munipack find 0716.${FILTER}.fits + munipack aphot 0716.${FILTER}.fits + munipack astrometry -c 'cone.fits[1][$f.mag$>11.and.$f.mag$<15]' \ + 0716.${FILTER}.fits + munipack phcal --verbose --photsys-ref Johnson -f ${FILTER} --area 0.3 \ + -c 0716+71.fits --col-mag ${FILTER}mag --col-magerr e_${FILTER}mag \ + $THRESH $SAPER 0716.${FILTER}.fits +done + + for FILTER in V R; do # manual for A in 0716_*${FILTER}.fits; do munipack phcal -C 1 --photsys-ref Johnson -f ${FILTER} \ - --saper 4 -O --mask '\!\1_mancal.\2' $A; + $SAPER -O --mask '\!\1_mancal.\2' $A; done # mancal, aperture 7, extinction @@ -81,18 +96,16 @@ --photsys-ref Johnson --area 0.3 \ -f ${FILTER} --col-mag ${FILTER}mag --col-magerr e_${FILTER}mag \ -c 0716+71.fits \ - --saper 4 \ - -O --mask '\!\1_catcal.\2' \ - $A; + $THRESH $SAPER \ + -O --mask '\!\1_catcal.\2' $A; done # reference frame for A in 0716_*${FILTER}.fits; do munipack phcal \ - --photsys-ref Johnson --area 0.3 \ - -f ${FILTER} \ - --saper 4 \ - -r 0716_035${FILTER}_catcal.fits -O --mask '\!\1_refcal.\2' $A; + --photsys-ref Johnson -f ${FILTER} --area 0.3 \ + $THRESH $SAPER -r 0716.${FILTER}_cal.fits \ + -O --mask '\!\1_refcal.\2' $A; done # ucac @@ -100,16 +113,34 @@ munipack phcal \ --photsys-ref Johnson --area 0.3 --col-ra RAJ2000 --col-dec DEJ2000 \ -f ${FILTER} --col-mag ${FILTER}mag --col-magerr e_${FILTER}mag \ - -c cone_Johnson.fits \ - --saper 4 \ - -O --mask '\!\1_ucacal.\2' \ - $A; + -c "cone_Johnson.fits[1][e_${FILTER}mag<0.1]" $THRESH $SAPER \ + -O --mask '\!\1_ucacal.\2' $A; done done -#munipack kombine --rcen 110.47 --dcen 71.34 --width 640 --height 480 -o V.fits 0716_*V.fits -#munipack kombine --rcen 110.47 --dcen 71.34 --width 640 --height 480 -o R.fits 0716_*R.fits +munipack kombine --average --rcen 110.47 --dcen 71.34 --width 640 --height 480 -o V.fits 0716_*V_catcal.fits +munipack kombine --average --rcen 110.47 --dcen 71.34 --width 640 --height 480 -o R.fits 0716_*R_catcal.fits + +#for FILTER in V R; do +# munipack find ${FILTER}.fits +# munipack aphot ${FILTER}.fits +# munipack astrometry -c 'cone.fits[1][$f.mag$>11.and.$f.mag$<15]' \ +# ${FILTER}.fits +# munipack phcal \ +# --photsys-ref Johnson --area 0.3 --col-ra RAJ2000 --col-dec DEJ2000 \ +# -f ${FILTER} --col-mag ${FILTER}mag --col-magerr e_${FILTER}mag \ +# -c "cone_Johnson.fits[1][e_${FILTER}mag<0.1]" $THRESH $SAPER \ +# -O --mask '\!\1_cal.\2' ${FILTER}.fits; +# +# # reference frame +# for A in 0716_*${FILTER}.fits; do +# munipack phcal \ +# --photsys-ref Johnson -f ${FILTER} --area 0.3 \ +# $THRESH $SAPER -r ${FILTER}_cal.fits \ +# -O --mask '\!\1_refcal.\2' $A; +# done +#done # light curves @@ -164,7 +195,10 @@ set yrange[14.8:13.5] set term svg dynamic set output 'lc0716_V.svg' -plot 'mancal_V' u (\$1-2453409):(\$2-\$4+11.8) t "diff(0716+71 - A) + 11.8", 'catcal_V' u (\$1-2453409):(\$2-0.2) t "std.field - 0.2" ls 1 lc 2, 'refcal_V' u (\$1-2453409):2 t "frame" ls 1 lc 3, 'ucacal_V' u (\$1-2453409):(\$2+0.1) t "UCAC4 + 0.2" ls 1 lc 4 +plot 'mancal_V' u (\$1-2453409):(\$2-\$4+11.8) t "diff(0716+71 - A) + 11.8", \ + 'catcal_V' u (\$1-2453409):(\$2-0.2) t "std.field - 0.2" ls 1 lc 2, \ + 'refcal_V' u (\$1-2453409):2 t "frame" ls 1 lc 3, \ + 'ucacal_V' u (\$1-2453409):(\$2+0.2) t "UCAC4 + 0.2" ls 1 lc 4 EOF @@ -173,10 +207,14 @@ set title "Calibration star A" set ylabel "magnitude in V" set xlabel "JD - 2453409" -set yrange[11.9:11.2] +set yrange[12:11] +set ytics 0.1 set term svg dynamic set output 'comp0716_V.svg' -plot 'mancal_V' u (\$1-2453409):(\$4-\$6+12.65) t "diff(A-B)+12.65", 'catcal_V' u (\$1-2453409):(\$4-0.1) t "std.field - 0.1" ls 1 lc 2, 'refcal_V' u (\$1-2453409):4 t "frame" ls 1 lc 3, 'ucacal_V' u (\$1-2453409):(\$4+0.1) t "UCAC4 + 0.2" ls 1 lc 4 +plot 'mancal_V' u (\$1-2453409):(\$4-\$6+12.65) t "diff(A-B)+12.65", \ + 'catcal_V' u (\$1-2453409):(\$4-0.1) t "std.field - 0.1" ls 1 lc 2, \ + 'refcal_V' u (\$1-2453409):4 t "frame" ls 1 lc 3, \ + 'ucacal_V' u (\$1-2453409):(\$4+0.2) t "UCAC4 + 0.2" ls 1 lc 4 EOF # plots, R filter @@ -188,7 +226,10 @@ set yrange[14.5:13.0] set term svg dynamic set output 'lc0716_R.svg' -plot 'mancal_R' u (\$1-2453409):(\$2-\$4+11.7) t "diff(0716+71 - A) + 11.7", 'catcal_R' u (\$1-2453409):(\$2-0.2) t "std.field - 0.2" ls 1 lc 2, 'refcal_R' u (\$1-2453409):2 t "frame" ls 1 lc 3, 'ucacal_R' u (\$1-2453409):(\$2+0.1) t "UCAC4 + 0.2" ls 1 lc 4 +plot 'mancal_R' u (\$1-2453409):(\$2-\$4+11.7) t "diff(0716+71 - A) + 11.7", \ + 'catcal_R' u (\$1-2453409):(\$2-0.2) t "std.field - 0.2" ls 1 lc 2, \ + 'refcal_R' u (\$1-2453409):2 t "frame" ls 1 lc 3, \ + 'ucacal_R' u (\$1-2453409):(\$2+0.1) t "UCAC4 + 0.1" ls 1 lc 4 EOF @@ -197,10 +238,14 @@ set title "Calibration star A" set ylabel "magnitude in R" set xlabel "JD - 2453409" -set yrange[11.8:10.8] +set yrange[11.7:10.7] +set ytics 0.1 set term svg dynamic set output 'comp0716_R.svg' -plot 'mancal_R' u (\$1-2453409):(\$4-\$6+12.5) t "diff(A-B+12.5)", 'catcal_R' u (\$1-2453409):(\$4-0.1) t "std.field - 0.1" ls 1 lc 2, 'refcal_R' u (\$1-2453409):4 t "frame" ls 1 lc 3, 'ucacal_R' u (\$1-2453409):(\$4+0.1) t "UCAC4 + 0.2" ls 1 lc 4 +plot 'mancal_R' u (\$1-2453409):(\$4-\$6+12.5) t "diff(A-B+12.5)", \ + 'catcal_R' u (\$1-2453409):(\$4-0.1) t "std.field - 0.1" ls 1 lc 2, \ + 'refcal_R' u (\$1-2453409):4 t "frame" ls 1 lc 3, \ + 'ucacal_R' u (\$1-2453409):(\$4+0.1) t "UCAC4 + 0.1" ls 1 lc 4 EOF @@ -214,7 +259,10 @@ set yrange[17:16.3] set term svg dynamic set output 'ext.svg' -plot 'ext_R' u 2:6 t "R total flux", 'ext7_R' u 2:6 t "R flux in 7-th aperture" ls 1 lc 2, 'ext_V' u 2:6 t "V total flux", 'ext7_V' u 2:6 t "V flux in 7-th aperture" ls 1 lc 2 +plot 'ext_R' u 2:6 t "R total flux", \ + 'ext7_R' u 2:6 t "R flux in 7-th aperture" ls 1 lc 2, \ + 'ext_V' u 2:6 t "V total flux", \ + 'ext7_V' u 2:6 t "V flux in 7-th aperture" ls 1 lc 2 EOF @@ -227,7 +275,8 @@ set yrange[0:15] set term svg dynamic set output 'rf90.svg' -plot 'rf90_R' u (\$1-2453409):2 t "R filter", 'rf90_V' u (\$1-2453409):2 t "V filter" ls 1 lc 2 +plot 'rf90_R' u (\$1-2453409):2 t "R filter", \ + 'rf90_V' u (\$1-2453409):2 t "V filter" ls 1 lc 2 EOF # aperture affair @@ -239,5 +288,8 @@ set yrange[-0.4:-1.4] set term svg dynamic set output 'apertures.svg' -plot 'mancal_V' u (\$1-2453409):(\$4-\$6) t "total flux", 'mancal7_V' u (\$1-2453409):(\$4-\$6 + 0.1) t "aperture 7-th" ls 1 lc 2, 'mancal4_V' u (\$1-2453409):(\$4-\$6 - 0.1) t "aperture 4-th" ls 1 lc 3, 'mancal10_V' u (\$1-2453409):(\$4-\$6 + 0.2) t "aperture 10-th" ls 1 lc 4 +plot 'mancal_V' u (\$1-2453409):(\$4-\$6) t "total flux", \ + 'mancal7_V' u (\$1-2453409):(\$4-\$6 + 0.1) t "aperture 7-th" ls 1 lc 2, \ + 'mancal4_V' u (\$1-2453409):(\$4-\$6 - 0.1) t "aperture 4-th" ls 1 lc 3, \ + 'mancal10_V' u (\$1-2453409):(\$4-\$6 + 0.2) t "aperture 10-th" ls 1 lc 4 EOF diff -Nru munipack-0.5.9/doc/lctut.shtml munipack-0.5.10/doc/lctut.shtml --- munipack-0.5.9/doc/lctut.shtml 2017-07-17 23:03:48.000000000 +0000 +++ munipack-0.5.10/doc/lctut.shtml 2018-01-16 17:58:03.000000000 +0000 @@ -493,7 +493,7 @@ lctut.sh is a bash script summarizing of this tutorial, ucac_jmuc.py is Python utility (requires -) which converts UCAC4 +Astropy) which converts UCAC4 r,i magnitudes in Gunn to R,I Johnson photometry system.

    diff -Nru munipack-0.5.9/doc/m27.sh munipack-0.5.10/doc/m27.sh --- munipack-0.5.9/doc/m27.sh 1970-01-01 00:00:00.000000000 +0000 +++ munipack-0.5.10/doc/m27.sh 2018-01-16 17:58:03.000000000 +0000 @@ -0,0 +1,24 @@ + +cd /tmp/ +tar zxf munipack-data-m27.tar.gz +cd munipack-data-m27/ +munipack dark -o d60.fits d60_*.fits +munipack phcorr -dark d60.fits m27_*B.fits +munipack dark -o d40.fits d40_*.fits +munipack phcorr -dark d40.fits m27_*[VR].fits + +munipack find m27_*.fits +munipack aphot m27_*.fits + + +munipack cone -r 0.1 -- 299.87 22.71 +munipack astrometry -c cone.fits m27_*.fits + +munipack kombine -o m27_B.fits --rcen 299.9 --dcen 22.72 m27_*B.fits +munipack kombine -o m27_V.fits --rcen 299.9 --dcen 22.72 m27_*V.fits +munipack kombine -o m27_R.fits --rcen 299.9 --dcen 22.72 m27_*R.fits + +munipack coloring -c 'Johnson BVR' -o m27.fits m27_B.fits m27_V.fits m27_R.fits +munipack ctrafo -o m27_xyz.fits -c 'XYZ' m27.fits 1e4,0.66 24e3,1 52e3,1 + +fitspng -fl 0,3e4 -o m27.png m27.fits diff -Nru munipack-0.5.9/doc/Makefile.am munipack-0.5.10/doc/Makefile.am --- munipack-0.5.9/doc/Makefile.am 2017-07-17 23:03:48.000000000 +0000 +++ munipack-0.5.10/doc/Makefile.am 2018-01-16 17:58:03.000000000 +0000 @@ -8,17 +8,19 @@ SUFFIXES: .shtml .html TARGETS= munipack.html features.html download.html docs.html notfound.html \ - basic.html external.html classics.html cbasic.html \ - ctutorial.html colorspace.html colorfits.html \ + basic.html external.html classics.html colorspace.html colorfits.html \ itone.html guide.html faq.html vobs.html history.html \ modules.html credits.html pererr.html lctut.html kombitut.html \ - phcorrtut.html colorimage.html colorcal.html colcal.html cmd.html chart.html \ + phcorrtut.html colorimage.html colorcal.html colcal.html cmd.html \ + chart.html \ man_intro.html man_help.html man_coloring.html man_ctrafo.html \ man_bias.html man_dark.html man_flat.html man_phcorr.html \ - man_cone.html man_astrometry.html man_phcal.html man_aphot.html man_gphot.html \ + man_cone.html man_astrometry.html man_phcal.html man_aphot.html \ + man_gphot.html \ man_list.html man_fitsut.html man_votable.html man_com.html \ man_env.html man_kombine.html man_timeseries.html man_setup.html \ - dataform_tmseries.html dataform_photometry.html dataform_astrometry.html \ + dataform_tmseries.html dataform_photometry.html \ + dataform_astrometry.html \ dataform_photosys.html dataform_phfotran.html dataform_proc.html \ dataform_biasdark.html dataform_flat.html mosaics.html \ phcalibration.html phoverview.html astoverview.html deka154.html \ @@ -26,9 +28,9 @@ fwhm.html changes.html debbuilder.html debbundle.html rpmbuilder.html \ rpmbundle.html install.html version.html SourceInstallation.html \ grow.html dataform_growrep.html man_artificial.html artific.html \ - shcripts.html + shcripts.html flatfielding.html -PADDING = README.docs munipack.css favicon.ico henden_m67.sh \ +PADDING = README.docs munipack.css favicon.ico henden_m67.sh m27.sh \ robots.txt 0716+71.lst timeserie_cat.lst lctut.sh ucac_jmuc.py \ artificial.sh kombitut.sh mosaic.sh Kepler-21b.lst fourier.lst @@ -45,3 +47,5 @@ #install-exec-hook: # cd $(docdir) && $(LN_S) munipack.html index.html # We got a problem when the link already exists. + +CLEANFILES = *.html diff -Nru munipack-0.5.9/doc/Makefile.in munipack-0.5.10/doc/Makefile.in --- munipack-0.5.9/doc/Makefile.in 2017-07-17 23:04:25.000000000 +0000 +++ munipack-0.5.10/doc/Makefile.in 2018-01-16 17:58:15.000000000 +0000 @@ -167,7 +167,11 @@ CC = @CC@ CCDEPMODE = @CCDEPMODE@ CFLAGS = @CFLAGS@ -CLEANFILES = @CLEANFILES@ + +#install-exec-hook: +# cd $(docdir) && $(LN_S) munipack.html index.html +# We got a problem when the link already exists. +CLEANFILES = *.html CPP = @CPP@ CPPFLAGS = @CPPFLAGS@ CXX = @CXX@ @@ -265,7 +269,6 @@ builddir = @builddir@ datadir = @datadir@ datarootdir = @datarootdir@ -develop = @develop@ docdir = @docdir@ dvidir = @dvidir@ exec_prefix = @exec_prefix@ @@ -295,17 +298,19 @@ top_builddir = @top_builddir@ top_srcdir = @top_srcdir@ TARGETS = munipack.html features.html download.html docs.html notfound.html \ - basic.html external.html classics.html cbasic.html \ - ctutorial.html colorspace.html colorfits.html \ + basic.html external.html classics.html colorspace.html colorfits.html \ itone.html guide.html faq.html vobs.html history.html \ modules.html credits.html pererr.html lctut.html kombitut.html \ - phcorrtut.html colorimage.html colorcal.html colcal.html cmd.html chart.html \ + phcorrtut.html colorimage.html colorcal.html colcal.html cmd.html \ + chart.html \ man_intro.html man_help.html man_coloring.html man_ctrafo.html \ man_bias.html man_dark.html man_flat.html man_phcorr.html \ - man_cone.html man_astrometry.html man_phcal.html man_aphot.html man_gphot.html \ + man_cone.html man_astrometry.html man_phcal.html man_aphot.html \ + man_gphot.html \ man_list.html man_fitsut.html man_votable.html man_com.html \ man_env.html man_kombine.html man_timeseries.html man_setup.html \ - dataform_tmseries.html dataform_photometry.html dataform_astrometry.html \ + dataform_tmseries.html dataform_photometry.html \ + dataform_astrometry.html \ dataform_photosys.html dataform_phfotran.html dataform_proc.html \ dataform_biasdark.html dataform_flat.html mosaics.html \ phcalibration.html phoverview.html astoverview.html deka154.html \ @@ -313,9 +318,9 @@ fwhm.html changes.html debbuilder.html debbundle.html rpmbuilder.html \ rpmbundle.html install.html version.html SourceInstallation.html \ grow.html dataform_growrep.html man_artificial.html artific.html \ - shcripts.html + shcripts.html flatfielding.html -PADDING = README.docs munipack.css favicon.ico henden_m67.sh \ +PADDING = README.docs munipack.css favicon.ico henden_m67.sh m27.sh \ robots.txt 0716+71.lst timeserie_cat.lst lctut.sh ucac_jmuc.py \ artificial.sh kombitut.sh mosaic.sh Kepler-21b.lst fourier.lst @@ -390,6 +395,9 @@ favicon-gprofile.png \ favicon.png \ fedora_icon.png \ + flatfielding.png \ + flatfine.png \ + flatzero.png \ gphoto.png \ gplv3-127x51.png \ gplv3-88x31.png \ @@ -446,12 +454,15 @@ ngc637_mini.jpeg \ Kepler-21b.svg \ comp0716_V.svg \ + flatdebug_3.svg \ + flatdebug_zero.svg \ grow_curve.svg \ grow_curve_anotated.svg \ lc0716_V.svg \ lcapprox.svg \ ngc637.svg \ - res_fill.svg + res_fill.svg \ + wrinkledflat.svg dist_html_DATA = $(TARGETS) $(image_list) $(PADDING) all: all-am @@ -675,10 +686,6 @@ .shtml.html: $(AWK) -f include.awk $< > $@ -#install-exec-hook: -# cd $(docdir) && $(LN_S) munipack.html index.html -# We got a problem when the link already exists. - # Tell versions [3.59,3.63) of GNU make to not export all variables. # Otherwise a system limit (for SysV at least) may be exceeded. .NOEXPORT: diff -Nru munipack-0.5.9/doc/man_artificial.shtml munipack-0.5.10/doc/man_artificial.shtml --- munipack-0.5.9/doc/man_artificial.shtml 2017-07-17 23:03:48.000000000 +0000 +++ munipack-0.5.10/doc/man_artificial.shtml 2018-01-16 17:58:03.000000000 +0000 @@ -90,6 +90,14 @@ The extinction coefficient k depends on a spectral band.

    +

    + The sky brightness (see below) is modelled by the same way + (bZ is its zenit value) +

    +

    + b(X) = bZ e-k(X-1) +

    +

    Modelling of seeing

    @@ -188,8 +196,8 @@ simulating of short exposures.

  • Fourier convolution -- this method generates both diffraction profile and Gaussian with the Fried's width. The profiles are convoluted - with help of convolution theorem and - FFT. This method is fast and results are perfectly smooth. + with help of convolution theorem and + FFT. This method is fast and results are perfectly smooth.

    All stars, on the image, are modelled with the same profile.

    @@ -209,50 +217,80 @@

    - where B0 is a mean level (--back-level) + where B0 is a mean level (derived + from --skymag) at centre of the picture x0, y0, N(b, Δb) is a function which makes a noise with - Normal distribution. - The parameters are mean level b and standard deviation Δb - (--back-noise). - If Δb is not set, it is defined as Δb = √ B0. + Normal + distribution. + The parameters are mean level b and standard deviation Δb, + which is computed as Δb = √ B0. +

    + +

    The optional gradient in background in counts per pixels is given by terms ΔBx, ΔBy - (--back-grad-x, --back-grad-y). It can do modelling of - a light pollution (by Moon). The common values for gradients are inside - interval -1 … 1. + (--sky-grad-x, --sky-grad-y). It can do modelling of + a light pollution (by Moon). The common values for gradients are + of order 0.0001 … 0.001 (negative values means negative slope of + the plane in given direction). +

    + + + + + + + + + + +
    Common sky brightness in zenit
    value [mag/arcsec2]light conditions
    above 22natural sky, high-altitude observatory
    22dark place, excellent night
    21countryside sky, average night
    20suburban sky, poor night
    18urban sky, full Moon
    under 17city sky, twilight
    + +

    + Values in the table are rought and determined by my observing + experiences + (wiki page⤴).

    Star fields

    - Field stars are generated by a random number generator - in case if no -c option is presented. Catalogue - star coordinates and magnitudes are used otherwise. + Field stars are generated by a random number generator, + if no -c option (a catalogue) is presented. + Catalogue star coordinates and magnitudes are used otherwise.

    - Coordinates of the stars has - uniform distribution in ranges given by frame size. + Rectangular (without projection) coordinates of the stars has + + uniform distribution in ranges given by a frame size. The standard Fortran random number generator, with no initial seed, is used.

    - I derived the rough approximation + Magnitude distribution, meaning a probability to found number + of stars in given magnitude interval per square degree, is + modelled as an exponential function with a cut-off to prevent + Olbersʼ + paradox. + I derived a rough approximation of the observed (surface) distribution of stars by brightens from DR1 by Gaia mission:

    - Σ(m) = 10-4 · e1.1m [□°] + Σ(m) = 10-4 · e1.1m [□°],   + m < m0

    - The quantity describes probability to found counts of stars - of given magnitude per square degree. -

    + The cut-off m0 is given by --maglim + parameter. +Large values of m0 and large field of view +can effectively exhaust the computer memory.

    The distribution approximation must be considered as an effective description. @@ -329,7 +367,7 @@

    --beta β
    Value of β exponent of Moffat profile (β > 0, β ≠ 1).
    -
    --maglim mag
    +
    --maglim m0
    Sets the most faint stars on frame for random generated field stars. This option is active only when star catalogue (by -c,--cat) is not used. @@ -367,16 +405,15 @@ are undefined, the centre of projection (as --rcen, --dcen) is used.
    -
    --back-level B
    - Sets level of background as a positive number. -
    -
    --back-noise b
    - Sets noise of background. If not given (or negative value passed), the - square root of the background level is used. -
    -
    --back-grad-x bx, --back-grad-y by
    - Background gradient in counts per pixel. It can simulate a light - pollution (by Moon). +
    --sky-mag skymag
    + Set sky brightness in magnitudes per square arcsecond. + Default value is 21 meaning good observing conditions. +
    +
    --sky-grad-x xmag, --sky-grad-y ymag
    + Background change in magnitues per square arcsecond and pixel + in given direction. + The order of common values is in the interval 0.0001 … 0.001. + It simulates a light pollution (by Moon).
    --area area
    The detection area of a simulated telescope in square meters. @@ -442,9 +479,6 @@

    Examples

    -

    -Common usage -

       $ munipack artificial
       $ xmunipack artificial.fits
    @@ -460,7 +494,7 @@
       It contains magnitudes (optionally, with errors)
       with columns: TIME,MAG,MAGERR.
       Records in the table must be sorted in time-increasing
    -  order. Overview does demonstrate usage.
    +  order. Overview describes its application.
       

    Table of Fourier coefficients

    diff -Nru munipack-0.5.9/doc/man_astrometry.shtml munipack-0.5.10/doc/man_astrometry.shtml --- munipack-0.5.9/doc/man_astrometry.shtml 2017-07-17 23:03:48.000000000 +0000 +++ munipack-0.5.10/doc/man_astrometry.shtml 2018-01-16 17:58:04.000000000 +0000 @@ -40,6 +40,86 @@
  • +

    Reccomendations

    + +

    The matching process is searching for a mutual correspondece + in two list of coordinates. The mathcing is generaly slow and + complex process. To increase of its reliability and speed, + is is important to compare (and prepare) the list by such way + so that the coordinates as well as magnitues overlaps. + The overlap in coodinates means to use of catalogues selection + with very similar centre and radius as the frames. Also + magnitude overlap must corresponds with non-saturated (and non-faint) + stars on images. (If both the conditions will not meet, the + matching will probbaly also sucessufll.) +

    + +

    + There two ways how to realise. The coordinate correspondece + can be make with known object position and field of view (FOV) + of telescope (it means angular diameter of the cone on sky) + in degress. If the telescope has FOV 0.5 deg and the observed + objects is Crab nebulae than the optimal selection from + UCAC4 cataloguje is: +

    +
    +  munipack cone -r 0.2 -- 83.63 22.01
    +
    + +

    + The magnitude selection is simliar. It depends on all telescope, + exposure time and filter. The mathcing (as well as photometry) + will sucesfull only with non-saturated bright stars. If we have + an experinece that the stars are saturated at 12, than + the catalogue selection can be improved (syntax is + column_name=[some constrain]): +

    +
    +  munipack cone -r 0.2 --par 'f.mag=>12' -- 83.63 22.01
    +
    + +

    + Alternatively, the filtration capabailities of FITSIO can be used +

    +
    +  munipack astrometry -c 'cone.fits[1][$f.mag$>12]' crab.fits
    +
    +

    + We are selecting only non-saturated stars fainter than magnitude 12 + in column f.mag. The usual linear range of 16-bit CCD cameras is + about 3-5 magnitudes. +

    + +

    + Parameter --maxmatch slices the catalogue on parts with similar + magnitudes (magnitudes in certain range). This is due to sorting + of both catalpogue and frame by magnitudes. +

    + +

    + Parameter --minmatch sets minimal length of match sequence + which is supposet to by complete (sucesfull match). For sparse + fileds, the defaults are usually satisfactyory, but very dense + fields like SMC, LMC needs increase this parameters. Munipack + sets the default of 5. If the mean surface density exceeds + the limit (?), the parameter is increased. The small values + on crowded fiedls can produce false match (because probability + of miss-match is getting appreciable). +

    + + + + + + + + + +
    Suitable parameters for astrometric calibration
    CaseSolution
    sparse field, < 1 m telescopedefaults
    crowded field, < 1 m telescope--minmatch=7, --maxmatch=44
    sparse field, > 1 m telescope-c 'cone.fits[1][$f.mag$>14]'
    crowded field, > 1 m telescope--minmatch=7, --maxmatch=44, -c 'cone.fits[1][$f.mag$>14 .and. $f.mag$<20]'
    + + + +

    Algorithm

    @@ -96,12 +176,6 @@
  • Angles computed between all stars in a real space must be inside tolerance.
  • -
  • the sequence must have first and last stars connected (all implemented tests must be passed).
  • @@ -223,10 +297,6 @@
  • robust (by default).
  • -

    Parameters For Matching:

    @@ -245,12 +315,25 @@ sparse fields with a few stars only will enough 3-5. To use match algorithm minimal length is 3. Upper limit is given by --maxmatch.
    --maxmatch n
    Set maximum count of objects for matching. - The default is 33 or count of objects in catalogue or in frame. There is no upper - limit, but values over hundredth are probably unusable. The recommended value - for crowded field is 30 - 50.
    -
    --disable-full-match
    finish when a first successful match - has occurred (normally, the full matching is performed, eg. the matching - algorithm explores all possible and acceptable combinations of stars)
    + The default is 33 or count of objects in catalogue or in frame. + There is no upper limit, but values over hundredth are probably unusable. + The recommended value for crowded field is 30 - 50. +
    --luckymatch n
    Set the number which is added to + value given by --minmatch and supposed to indicate + a reliable sequence. For instance, --minmatch 5 + and --luckymatch 3 indicates good match when result + has at least 8 successful matches. Default values is 3. + It is reliable like full match and fast like use of first + successful match, if the value is greater than 1. +
    +
    --disable-lucky-match
    + Finish at first success match when --minmatch + is reached. Alias for --luckymatch 0 +
    +
    --enable-full-match
    without this option + finish when a first successful lucky match has occurred. + Full matching is performed when presented, eg. the matching + algorithm explores all possible and acceptable combinations of stars.
    --disable-flux-check
    To improve speed and reliability of matching, fluxes are used as the additional independent quantity for checking. This switch disables flux check completely. A possibility @@ -278,12 +361,12 @@ + -
    Following combinations of mode and options are possible
    ModeOptions
    match-c, -r, -R, Parameters for Matching
    sequence--seq1, --seq2, -c, -r, -R
    manual--projection, --xcen, --ycen, --rcen, --dcen, --scale, --angle, --reflex
    Following combinations of mode and options are possible
    @@ -319,7 +402,7 @@ catalogue

    -munipack cone -c UCAC5 -o 0716cat.fits -r 0.1 110.25 71.34
    +munipack cone -c UCAC5 -o 0716cat.fits -r 0.1 -- 110.25 71.34
     

    UCAC5 is the recommended astrometric catalogue (default). We must provide @@ -430,7 +513,7 @@ Virtual Observatory:

    -$ munipack -o 0716_cat.fits -r 0.2 cone 110.25 71.34
    +$ munipack -o 0716_cat.fits -r 0.2 cone -- 110.25 71.34
     

    Selected astrometric stars in radius 0.2° around centre @@ -447,22 +530,6 @@ of successful matching.

    - -

    Invoking of Matching

    @@ -575,10 +642,10 @@ Debug: CAT = 'cone.fits' Debug: FILE = '0716_006V.fits' '0716_006V.fits~' '' Selecting catalogue stars in rank: 1 33 - Matching... #: {seq1} -> {seq2} | scale,r: sq.(angle, scale, flux) < Xi2(0.95) + Matching... #: {seq1} -> {seq2} | scale,r: sq.(angle, scale, flux) < Xi2(0.95) Astrometry calibration of `0716_006V.fits'. -17: 5 6 9 16 17 18 19 21 23 22 24 26 27 29 28 30 32 -> 1 2 3 5 6 4 13 10 7 11 12 9 8 18 14 21 16 | 1767.5 4.53: 1.36 .669E-001 15.7 < 26.0 -17: 28 29 5 6 9 16 17 18 19 21 23 22 24 26 27 30 32 -> 14 18 1 2 3 5 6 4 13 10 7 11 12 9 8 21 16 | 1767.5 4.53: .553 .710E-001 15.7 < 26.0 +17: 5 6 9 16 17 18 19 21 23 22 24 26 27 29 28 30 32 -> 1 2 3 5 6 4 13 10 7 11 12 9 8 18 14 21 16 | 1767.5 4.53: 1.36 .669E-001 15.7 < 26.0 +17: 28 29 5 6 9 16 17 18 19 21 23 22 24 26 27 30 32 -> 14 18 1 2 3 5 6 4 13 10 7 11 12 9 8 21 16 | 1767.5 4.53: .553 .710E-001 15.7 < 26.0 === Parameters estimation === # estim init scale [pix/deg]: 1767.6 0.1 # estim init reflexion: 1. diff -Nru munipack-0.5.9/doc/man_bias.shtml munipack-0.5.10/doc/man_bias.shtml --- munipack-0.5.9/doc/man_bias.shtml 2017-07-17 23:03:48.000000000 +0000 +++ munipack-0.5.10/doc/man_bias.shtml 2018-01-16 17:58:03.000000000 +0000 @@ -23,23 +23,23 @@

    A bias frame is a zero-time exposure with no light. The exposure with the shortest -possible exposure time provided by a device. One maps a pre-amplifier bias (offset) +possible exposure time provided by a device. One maps a pre-amplifier bias (offset) of readout electronics. This routine creates an average bias frame, sometimes named as a masterbias.

    -Because bias exposure times are really short (1/100s or less), it is +Because bias exposure times are really short (1/100s or less), it is recommended to acquire and average a lot of exposures (>10).

    -An output bias Bij is computed as the average of every pixel of +An output bias Bij is computed as the average of every pixel of input images (Ik)ij:

    -Bij = 〈Ikij, +Bij = 〈 Ikij,

    where i,j is an index of a pixel and k is an index of an image. @@ -47,16 +47,16 @@

    Two methods of averaging are implemented. An arithmetical mean -is fast and memory conserving while a robust mean is significantly slower and requires -much more memory. Use of the robust mean is preferred because random defects (cosmics, +is fast and memory conserving while a robust mean is significantly slower and requires +much more memory. Use of the robust mean is preferred because random defects (cosmics, interferences) are greatly suppressed.

    Both chip temperatures or exposure times are checked to be nearly the same -during processing when FITS_KEY_TEMPERATURE and FITS_KEY_EXPTIME -environment variables are set to values of -corresponding quantities. +during processing when FITS_KEY_TEMPERATURE and FITS_KEY_EXPTIME +environment variables are set to values of +corresponding quantities.

    Input And Output

    @@ -72,11 +72,16 @@

    Parameters

    -
    -a
    use arithmetical mean instead of default robust mean
    -
    --tol-temp temp
    limit for nearby temperatures (default = 1K)
    -
    --tol-exp exptime
    limit for nearby exposure times (default = 1 μsec)
    -
    -B bitpix
    set numerical type of output images, see Common options (default -32)
    -
    -o filename
    save to the output file, see Common options
    +
    --arith
    use arithmetical mean instead of + default robust mean
    +
    --tol-temp temp
    limit for nearby temperatures + (default = 1K)
    +
    --tol-exp exptime
    limit for nearby exposure times + (default = 1 μsec)
    +
    -B bitpix
    set numerical type of output images, + see Common options (default -32)
    +
    -o filename
    save to the output file, + see Common options

    Also see Common options

    @@ -113,4 +118,3 @@ - diff -Nru munipack-0.5.9/doc/man_com.shtml munipack-0.5.10/doc/man_com.shtml --- munipack-0.5.9/doc/man_com.shtml 2017-07-17 23:03:48.000000000 +0000 +++ munipack-0.5.10/doc/man_com.shtml 2018-01-16 17:58:03.000000000 +0000 @@ -350,12 +350,6 @@ barnard_0001R.fits -> barnard_0001R.fits
    - - -

    See also: wxRegEx, wxString

    diff -Nru munipack-0.5.9/doc/man_cone.shtml munipack-0.5.10/doc/man_cone.shtml --- munipack-0.5.9/doc/man_cone.shtml 2017-07-17 23:03:48.000000000 +0000 +++ munipack-0.5.10/doc/man_cone.shtml 2018-01-16 17:58:04.000000000 +0000 @@ -96,7 +96,7 @@ brighter than eleven:

    -munipack cone --par 'Vmag=<11' -- 245.9 -26.5
    +munipack cone --par 'Vmag=<11' -- 245.9 -26.5
     

    diff -Nru munipack-0.5.9/doc/man_ctrafo.shtml munipack-0.5.10/doc/man_ctrafo.shtml --- munipack-0.5.9/doc/man_ctrafo.shtml 2017-07-17 23:03:48.000000000 +0000 +++ munipack-0.5.10/doc/man_ctrafo.shtml 2018-01-16 17:58:03.000000000 +0000 @@ -57,10 +57,11 @@

    Examples

    Convert a color FITS image to a new colorspace. The black levels are -3700 (in B), 9300 (V) and 20300 (in R). The blue filter we get with 0.66 weight: + 10 thousand (in B), 24 thousand (V) and 52 thousand (in R). + The blue filter we get with 0.66 weight:

    -$ munipack ctrafo -o m27_xyz.fits -c 'XYZ' m27.fits 3700,0.66 9300,1 20300,1 +$ munipack ctrafo -o m27_xyz.fits -c 'XYZ' m27.fits 1e4,0.66 24e3,1 52e3,1
    diff -Nru munipack-0.5.9/doc/man_dark.shtml munipack-0.5.10/doc/man_dark.shtml --- munipack-0.5.9/doc/man_dark.shtml 2017-07-17 23:03:48.000000000 +0000 +++ munipack-0.5.10/doc/man_dark.shtml 2018-01-16 17:58:03.000000000 +0000 @@ -16,7 +16,7 @@

    Synopsis

    -munipack dark [-a] [-bias file] [--tol-temp] [--tol-exp] [..] file(s) +munipack dark [--arith] [-bias file] [--tol-temp] [--tol-exp] [..] file(s)

    Description

    @@ -29,7 +29,7 @@

    -An output image Oij is computed as the average of every pixel of +An output image Oij is computed as the average of every pixel of input images (Ik)ij:

    @@ -37,14 +37,14 @@

    where i,j is an index of a pixel and k is an index of an image. -When a bias frame Bij is available, one is subtracted from +When a bias frame Bij is available, one is subtracted from dark exposures before averaging.

    Two methods of averaging are implemented. An arithmetical mean -is fast and memory conserving while a robust mean is significantly slower and requires -much more memory. Use of the robust mean is preferred because random defects (cosmics, +is fast and memory conserving while a robust mean is significantly slower and requires +much more memory. Use of the robust mean is preferred because random defects (cosmics, interferences) are greatly suppressed.

    @@ -52,7 +52,7 @@ It is strongly recommended correct setting of FITS_KEY_EXPTIME (environment variables) because the exposure time will usable for later processing. -Chip temperatures are checked to be equal during processing when +Chip temperatures are checked to be equal during processing when FITS_KEY_TEMPERATURE is valuable.

    @@ -70,12 +70,17 @@

    Parameters

    -
    -a
    use arithmetical mean instead of default robust mean
    -
    -bias file
    use the specified bias frame
    -
    --tol-temp temp
    limit for nearby temperatures (default = 1K)
    -
    --tol-exp exptime
    limit for nearby exposure times (default = 1 μsec)
    -
    -B bitpix
    set numerical type of output images, see Common options (default -32)
    -
    -o filename
    save to the output file, see Common options
    +
    --arith
    use arithmetical mean instead of + default robust mean
    +
    -bias file
    use the specified bias frame
    +
    --tol-temp temp
    limit for nearby temperatures + (default = 1K)
    +
    --tol-exp exptime
    limit for nearby exposure times + (default = 1 μsec)
    +
    -B bitpix
    set numerical type of output images, + see Common options (default -32)
    +
    -o filename
    save to the output file, + see Common options

    Also see Common options

    @@ -112,4 +117,3 @@ - diff -Nru munipack-0.5.9/doc/man_flat.shtml munipack-0.5.10/doc/man_flat.shtml --- munipack-0.5.9/doc/man_flat.shtml 2017-07-17 23:03:48.000000000 +0000 +++ munipack-0.5.10/doc/man_flat.shtml 2018-01-16 17:58:04.000000000 +0000 @@ -2,20 +2,22 @@ -Munipack ‒ Averaged Flat-Field Frame +Munipack ‒ Flat-field frame -

    Averaged Flat-Field Frame

    +

    Flat-field frame

    -An average flat-field frame of a set of flat-field frames. + The flat utility is designed to + constructs of an average flat-field frame by + a set of individual flat-field frames.

    Synopsis

    @@ -27,51 +29,48 @@

    Description

    -The flat-field frame is a map of the photometric response of an instrument +A flat-field frame is a map of the photometric response of an instrument (both detector and optical configuration together). Flat-fields are used -to remove defects like dust, vignetting and -other imperfections on a single pixel base. Flat-fields can be acquired -on sky during twilight, as night sky images and the dome flats. -This routine creates the flat-field frame by averadging of a serie of such images. +to remove all imperfections like variable light sensitivity of pixels, +dust grains, vignetting and similar +effects on per-pixel basis. Flat-fields can be acquired +on sky during twilight, as night sky images, the dome flats +or by another technique.

    -

    -The output flat-field Fij is computed as the (robust) average -of every pixel of pre-scaled input images (I'k)ij: -

    -

    -Fij = 1/(1 - 〈I'kij), -

    -

    -where i,j is an index of a pixel and k is an index of an image. -Input images (Ik)ij are pre-scaled as -

    -

    -I'ij = (Iij - 〈Iij〉) / 〈Iij, - - +

    +This routine creates a new flat-field frame by averaging of +a set of such flat-fields. The averaging improves precision of +the flat-field by factor of square root of input frames count +(sixteen input frames increases precision by factor 4×). Moreover, +all defects presented on any single frame (like random +cosmics) are softly cleared.

    -

    -where the average of whole image is 〈Iij -. The rescaling is used to -unifying possible different light levels (in twilight flat-fields). + +

    + The output flat-field Fij is computed as the + massive sequence of non-linear implicit equations for every pixel + of every input frame, + which needs a lot of both computer power and time. + Amount of frames is limited only by available memory + (width × height × 4 × 2 bytes per frame). One hundred of + 1000×1000 frames takes 800MB.

    -

    The averaging of flat-fields is computed by the robust algorithm. -Amount of frames is not limited. Just a single frame can be provided, -which normalizes the input. Robust method works very well for -thirteen and more frames.

    +

    + Relative precision of a final flat-field increase as + square root of amount of input frames √N. + Implemented robust methods works well when amount of + input frames is over thirteen frames N > 13. + A single frame on input is normalised only. +

    -

    -The input flat-fields can be pre-corrected for both bias and dark: +

    + The input flat-fields should be preparatory corrected for all of these + gain, bias and dark:

    -Iij → Iij - x Dij - Bij. +Fij → g(Fij - x Dij - Bij).

    The meaning of x and the algorithm itself are the same as in @@ -79,78 +78,84 @@

    -The flat-field can be scaled onto an output -level. The default value is 1.0 which is suitable for any situation -when output is stored as float numbers (BITPIX=-32). When integer -numbers are preferred (a litle bit reduced numerical precision is acceptable), -set the output level -to the half of range for the integer data-types (for BITPIX=16 is range 65536 -and half about 30000. In the case, any photometric information is lost! +It is strongly recommended to set of correct value of FITS_KEY_FILTER +(environment variables), because +the filter identification in the FITS header of the flat-field +should be available for some later processing.

    -

    -It is strongly recommended correct setting of FITS_KEY_FILTER -(environment variables) because -the filter should be usable for later processing. -

    Gain estimate

    -Flat-fielding can be used to estimate of gain of a camera. -The estimation determines the standard deviation σ of residuals -between output mean and a single flat-field frame. σ ≈ 1 is near to one -for correct value of gain. This is basic property of -Poisson distribution -which has bounded value of number of detected particles n and its -standard deviation σ by relation σ=√n. The relation can be used -for only when other sources of noise are negligible. Therefore, the ideal -value of n is about half of full well capacity of detector (not ADU!). +Flat-fielding can be used to estimate of gain g of a camera. +The estimation determines +variance +σ2 and the mean value +c +of individual flat-field frames. Ratio satisfies the condition +c2 ≈ 1 +only for Poisson distributed data, when other sources of noise are negligible. +Values significantly violating the conditions +indicates that g is differ to one. +The recommended mean values for all c are about half of full well +capacity of a detector.

    -

    +

    The gain g is determined by the relation

    - -g = 1 / σ² - - -

    -The estimated values of standard deviation σ and gain are printed -in the output of the routine as last two columns of the table: +g = c / σ² +

    + +

    + The estimated values of variance σ2 and gain g + are printed on the output as the last two columns:

    -...
    - Filename, mean, correction,     std.dev., gain:
    -flat_V_000001.fits: 2.08154E+05  -16.34081     1.92080     0.271
    -flat_V_000002.fits: 1.84904E+05  -16.02431     1.89552     0.278
    -                                                 [σ]        [g]
    -...
    +  ...
    +  Filename,      mean level[ct],  std.err., reliable,  std.dev.,  gain:
    +                                                        [σ]        [g]
    +  ...
    +  flat-V_000002.fits:   1.15777E+05  58.5  T 339.14  1.007
    +  flat-V_000003.fits:   98909.  50.0  T 313.62  1.006
    +  ...
     
    -

    -Determination of gain is so slow that one is computed only on +

    + Gain is determined only on request by using of --gain-estimate switch -(verbose mode is invoked). +(verbose mode is invoked), because it slows down computations.

    -

    +

    + A recommended way to determine of gain is preliminary set + some value + (g=1 if no the right value is already known) and invoke + the estimate. + Than use the newly determined value + to set the gain again and repeat the procedure + while estimated gain will remain on value near to one + (with a few percent precision). +

    + +

    When gain keyword is available in the header, the values are -pre-scaled by the gain so results will realtive against to the -value. To suppres use of the value, set gain by providing --gain 1. +initially scaled by the gain so results will be determined relative +against to the value.

    -

    -The estimation of value of gain is just indicative and the check by some -alternative method (factory provided, …) is highly recommended! +

    +The estimation of value of gain is just indicative and to check by some +alternative method (factory provided, …) is highly recommended.

    -

    Input And Output

    +

    Input and output

    -On input, list of frames representing the flat-fields is expected. Optionaly, -both bias and dark can by pre-applied on every frame. + On input, list of observed flat-fields is expected. + Optionally, all gain, bias and dark corrections can + by applied on every frame.

    @@ -160,40 +165,75 @@

    Parameters

    +
    -gain g
    provide value of gain (rather than + FITS keyword) in [e-/ADU]
    -bias file
    bias frame
    -dark file
    dark frame
    -xdark x
    dark frame multiplicative factor
    -
    -gain g
    provide value of gain (rather than FITS keyword)
    -
    --gain-estimate
    Try to estimate gain of every frame. - The estimate importantly slow-down flat-fielding. - Please, pre-set gain on the unit by using -gain 1
    -
    --saturate s
    Set saturation level. All value out of range: - 0 < flat < s, in input files are rejected from any processing. - This switch is useful mainly for over-exposed flat-fields. - If unused, the value is get from FITS header (by FITS_KEY_SATURATE, - see). If the keyword is not found in the header, - and frame has number type of integer, the maximum value 2**BITPIX is - used, otherwise - maximum value of the first frame on input is used (which practically - switch-off saturation bound check).
    -
    --level x
    the mean level of output frame (default: 1.0)
    -
    -B bitpix
    set numerical type of output images (default -32)
    -
    -o filename
    save to the output file
    +
    -bitmask file
    mask frame (see + phcorr for description). Only pixels, + marked by this mask are processed. +
    +
    -st, --saturate s
    Set saturate limit in + units of input frames. + All pixels with values out of the range + th < flat < s (see also --threshold) + are rejected from any processing. + This switch is useful mainly for over-exposed flat-fields + and elimination of non-linear parts of gradation curve. + If leaved unset, the value is determined from FITS header + (by FITS_KEY_SATURATE, see). + If the keyword is not found and the frame contains + an integer number type, the maximum value 2**BITPIX-1 is + provided, otherwise the maximum value of the first frame on input + is used (which practically switch-off the saturation bound check). + The value is set in ADU (values reported by camera). +
    +
    -th, --threshold th
    Set threshold limit + in units of input frames. + All pixels below the value are rejected from any processing. + If unset, the value is zero. Threshold is minor significance parameter. + It should help in case of faulty values in frames or filtering + of bad flat-fields. Its recommended value is inside interval + from zero to one quarter of full range. + The value is set in ADU (values reported by camera). +
    +
    --gain-estimate
    Rough estimate of gain. +
    +
    --approximation [basic|standard]
    + Basic approximation computes only robust mean of all flat-fields. + It is only very rough estimate. + The standard approximation provides more precise + solution on base of the basic initial estimate. +
    +
    -B bitpix
    Set numerical type of output images. + Only the default -32 should be used. + The mean value of outputs will be changed to 100, 104, + 109 for BITPIX 8,16 and 32. +
    +
    -o filename
    save to the output file

    Also see Common options

    -

    Examples

    - - -$ munipack flat -o f_R.fits -dark d10.fits f10_*R.fits - +

    Environment variables

    -If one needs frame with natural light-level and 16-bit depth, one is using +FITS_KEY_FILTER, FITS_KEY_DATEOBS, FITS_KEY_EXPTIME, FITS_KEY_IMAGETYP, +FITS_KEY_GAIN, FITS_KEY_SATURATE +(see Environment variables). +

    + +

    + No one is mandatory, but remember, a flat-field with no filter + identification is like heavy water without neutron.

    + + +

    Examples

    + -$ munipack flat -B 16 --level 10000 -o f_R.fits -dark d10.fits f10_*R.fits +$ munipack flat -o f_R.fits -gain 2.3 -dark d30.fits -st 6e4 f30_*R.fits
    @@ -211,11 +251,13 @@
    -

    See Also

    -

    Light Curve Tutorial, -Photometric corrections tutorial, -Averaged bias frame, -Averaged dark frame. +

    See also

    +

    + Flat-fielding, + Light curve tutorial, + Photometry corrections tutorial, + Averaged bias frame, + Averaged dark frame.

    diff -Nru munipack-0.5.9/doc/man_gphot.shtml munipack-0.5.10/doc/man_gphot.shtml --- munipack-0.5.9/doc/man_gphot.shtml 2017-07-17 23:03:48.000000000 +0000 +++ munipack-0.5.10/doc/man_gphot.shtml 2018-01-16 17:58:04.000000000 +0000 @@ -34,6 +34,13 @@ sum of counts from a star in predefined apertures.

    +

    Apperture correction determination

    + +

    +

    + + +

    Parameters

    -th, --threshold
    The diff -Nru munipack-0.5.9/doc/man_kombine.shtml munipack-0.5.10/doc/man_kombine.shtml --- munipack-0.5.9/doc/man_kombine.shtml 2017-07-17 23:03:48.000000000 +0000 +++ munipack-0.5.10/doc/man_kombine.shtml 2018-01-16 17:58:04.000000000 +0000 @@ -10,7 +10,7 @@

    Kombine

    -Multiple-frames are composed to a single image. +Multiple frames are composed to a single image.

    Command

    @@ -22,8 +22,9 @@

    Description

    -Purpose of this routine is compound images to get more deeper exposure, -to increase the dynamic range or to create of a mosaics. +Purpose of this routine is to compound images into a deeper exposure, +to increase its dynamic range, to average frames or to create of a mosaics +covering larger area than any single frame.

    @@ -38,40 +39,75 @@

    Prerequisites

    -Needs both astrometry and photometry. + Kombine needs astrometry. A regular photometry is necessary + for averaging.

    Input And Output

    -On input, list of frames containing both astrometric and photometric information -is expected. + On input, list of frames meeting the prerequisites.

    On output, a new FITS frame is created.

    -

    Parameters

    +

    Averaging

    +

    + Averaging (--average) can create clean up average + frames. The averaging can be applied only on already photo-metrically + calibrated frames including PHOTOMETRY extension created by + phcal. The result frame has mean + intensity and background of input frames. +

    +

    Initialisation of parameters

    -Optional parameters: + The paramaters are inherited from parameters of the first + frame on input, if no corresponding parametr is set by command + line option. The strategy is chosen as the less surprising + way. The output frame looks similary as inputs ones.

    -
    -
    -i
    interpolation method: none,bilinear,bicubic (default)
    -
    --adjust
    adjust sky level of individual exposures
    -
    --expomask
    use exposure mask to normalise photon rates
    -

    -Geometry parameters: + The live will more easy with the zero rotation + angle (--angle 0) and + no reflection (--reflex no) of output frames.

    + + +

    Parameters

    + +

    Parameters for composition:

    +
    +
    -i, --interpol
    interpolation method: + none (nearest + neighborhood), + bilinear, + bicubic + (default)
    +
    --adjust
    adjust sky level of individual + exposures
    +
    --expomask
    use exposure mask to normalise + photon rates
    +
    --average
    compute the robust mean + for every single pixel instead of frames summation
    +
    + +

    Geometry parameters:

    -
    -p
    projection: none, gnomonic (default)
    -
    --xcen, --ycen
    centre of projection on chip [pix] (default: width/2, height/2)
    -
    --rcen, --dcen
    centre of projection in Right Ascension and Declination [deg]
    -
    --scale
    scale [pix/deg]
    -
    --angle
    positional angle [deg]
    +
    -p, --projection
    projection: none, gnomonic + (default)
    +
    --rcen, --dcen
    centre of projection in + Right Ascension and Declination [deg]
    +
    --width, --height
    dimensions of the output + frames in pixels
    +
    --xcen, --ycen
    centre of projection on chip [pix] + (default: width/2, height/2)
    +
    --scale
    scale [pix/deg]
    +
    --angle
    positional angle [deg]
    +
    --reflex
    [yes|no] setup reflection

    See Common options for input/output filenames.

    diff -Nru munipack-0.5.9/doc/man_phcal_params.shtml munipack-0.5.10/doc/man_phcal_params.shtml --- munipack-0.5.9/doc/man_phcal_params.shtml 2017-07-17 23:03:48.000000000 +0000 +++ munipack-0.5.10/doc/man_phcal_params.shtml 2018-01-16 17:58:04.000000000 +0000 @@ -51,12 +51,37 @@ (photometric system definitions) file.
    -

    Helper:

    +

    Common:

    +
    -th, --threshold
    Select stars on both reference + and calibrated frames (not applied on catalogues) with its stellar + flux to a sky noise (signal to noise) ratio greater then + the threshold value. Both the values are determined in the same aperture. + The proper + choice is crucial for photometry precision because it helps to select + only bright stars with minimal pollution by the sky noise. The default + value 5 is very conservative setup. It is suitable for bad conditions + (like urban or a full moon light observations). Standard and good + conditions will allow lower ratios. In an ideal case, it can be + under one for best results. +
    +
    -e, --maxerr
    Select stars on both reference + and calibrated frame (not applied on catalogues) with its relative + flux error smaller than the error limit. The value does not limits + the final precision, but limits fluency of noisy data. + The default value 0.1 (ten percents, about tenth of magnitude) + will also include relative imprecise stars into both calibration and + calibrated set. The values under 0.01 and lower will select + only precise and suitable calibration stars. +
    --area
    Area of telescope aperture in square meters [m2].
    --saper
    selects appropriate aperture from PHOTOMETRY extension. By default, flux in infinite aperture is used.
    +
    --apcorr
    sets the aperture correction. + This correction converts fluxes in an aperture to the total flux + (infinite aperture). The value of correction should be obtained + by gphot.
    --advanced
    Advanced format. Additional extensions (results of star find, photometry and residuals) are included. This format is not used by default because result FITS diff -Nru munipack-0.5.9/doc/man_phcorr.shtml munipack-0.5.10/doc/man_phcorr.shtml --- munipack-0.5.9/doc/man_phcorr.shtml 2017-07-17 23:03:48.000000000 +0000 +++ munipack-0.5.10/doc/man_phcorr.shtml 2018-01-16 17:58:04.000000000 +0000 @@ -25,7 +25,7 @@

    Photometry corrections are important for any further processing of astronomical -images. Their proper applications ensures photometry calibration, +images. Their proper applications ensures photometry calibration, eg. the constant ratio between detected electrons and expected photons.

    @@ -40,9 +40,9 @@ Their subtraction is important when absolute photometry calibration is required.
  • The dark correction reduces signal produced by the thermal noise of apparatus and improves photometry precision about thousandths or hundredths. -
  • +
  • The flat-field describes spatial (angular) variation in detector sensitivity. -The flat-field correction is crutial for any valuable photometry work +The flat-field correction is crutial for any valuable photometry work and improves precision from tenths to thousandths.
  • @@ -50,18 +50,18 @@

    Algorithm

    -A photometric corrected image Icij is computed +A photometric corrected image Icij is computed for every input image Iij as

    Icij = (g Iij - x Dij - Bij)/fij,

    -where i,j is an index of a pixel, g is gain, Dij -is the dark frame, -x is a multiplication factor (see below). Bij +where i,j is an index of a pixel, g is gain, Dij +is the dark frame, +x is a multiplication factor (see below). Bij is the bias frame -and fij is the normalised flat-field frame (with absolute +and fij is the normalised flat-field frame (with absolute photometry fluxes conserved):

    @@ -75,20 +75,20 @@ In case, that bias or dark is undefined, their values are set to zero (in real numbers). When flat-field is missing, values are fij=1 (real). -If |〈Fij〉| is under machine precision, the -value fij=0 (real) is set for all pixels. -When fij is (machine) zero, the +If |〈Fij〉| is under machine precision, the +value fij=0 (real) is set for all pixels. +When fij is (machine) zero, the Icij=0 (real).

    -The multiplication factor x is determined by the way: when parameter --xdark is -provided, its value is used, otherwise ratio of exposure times +The multiplication factor x is determined by the way: when parameter +-xdark is +provided, its value is used, otherwise ratio of exposure times T of the scientific exposure I and the dark frame D are used as x= TI / TD. Both exposure times are extracted from FITS header -(given by FITS_KEY_EXPOSURE environment +(given by FITS_KEY_EXPOSURE environment variable). When the ratio can not be determined by previous way, the x=1 is silently set (this choice is compatible to traditional methods).

    @@ -96,7 +96,7 @@

    It is recommended to use averaged values of all correction images B,D,F produced by bias, -dark and flat. +dark and flat.

    @@ -109,7 +109,7 @@

    A common CCD camera captures electrons produced by photons illuminating -pixels. These electrons are usually not directly available, but the control +pixels. These electrons are usually not directly available, but the control electronics converts their counts to another counts via analogue to digital converter with a gain g. New values and original ones are related by the relation @@ -118,15 +118,15 @@ (values provided by camera) = g* (count of electrons).

    -The reason for this is usually due to storing usuall capacity of about 200k +The reason for this is usually due to storing usuall capacity of about 200k electrons per pixel to two bytes (range 0-65565).

    Because the primary quantity are electrons and we need acute the primary quantity for estimation of statistical errors, we must convert -values reported by camera to electrons for proper function of all other utilities. -The output frame is identical (on the first view), but values are multiplied +values reported by camera to electrons for proper function of all other utilities. +The output frame is identical (on the first view), but values are multiplied by the gain so values of output frames will generally different to originals.

    @@ -134,12 +134,12 @@

    Gain value is preferably get from FITS header where is identified by GAIN keyword. -If the value is not found, the input frame is not corrected. +If the value is not found, the input frame is not corrected.

    -The gain can be specified on command line with -gain. -In this case, the value is used rather than the value in header. +The gain can be specified on command line with -gain. +In this case, the value is used rather than the value in header. However, the usage is primary designed to correct a potentially wrong values of the gain.

    @@ -177,7 +177,7 @@ The second strategy requires little more processing, but it is ideal for many exposures with theirs different duration. A lot of biases is made and only a few long-duration darks is taken. This approach -is more flexible (when many exposure times is available) and also +is more flexible (when many exposure times is available) and also may save some observation time.

    @@ -185,7 +185,7 @@

    A array mask Mij can be applied on result image -with photometry corrections applied. The mask sets suppressed pixels +with photometry corrections applied. The mask sets suppressed pixels (where Mij=0) and other left unchanged (where Mij=1). The masking technique has been adopted from bitmap editors (in computer graphics fields) where masked values are @@ -205,8 +205,8 @@

    -A process for create of Mij is complex. One strongly depends -on values intended to by masked and on a masked image itself. Therefore there is +A process for create of Mij is complex. One strongly depends +on values intended to by masked and on a masked image itself. Therefore there is no an unique way, how to prepare it.

    @@ -225,34 +225,35 @@ MEAN (average)
    --tol-temp temp
    limit for nearby temperatures (default = 1 K)
    --tol-exp exptime
    limit for nearby exposure times (default = 1 μsec)
    -
    --normalise
    Normalise on averaged flat-field level. -The frames are just divided by flat-field frame. As the consequence, level of images -is reduced by factor 10 or more thousands and absolute photometry information -is loosed. The normalisation recovers original levels (by multiplication of original -flat-field level). Both frames must have the same gain. Averaged flat-field +
    --normalise
    Normalise flat-field before use. + The frames are just divided by flat-field frame. As the consequence, + the mean level of images is reduced by mean level of the flat + and as consequence, the absolute photometry information is loosed. + The normalisation keeps original levels (by multiplication of original + flat-field level). Both frames must have the same gain. Averaged flat-field frames produced by flat utility are normalised -on level one and normalisation is useless. Be careful with saving frames -to integer values (in this case normalisation must be used else all values +on level one and normalisation is useless. Be careful with saving frames +to integer values (in this case normalisation must be used else all values will zeros).
    --force
    Apply correction also on already corrected frames

    Also see Common options. Note that we have -similar parameters -bitmask and --mask with roughly +similar parameters -bitmask and --mask with roughly different meaning!

    Examples

    -

    Subtract dark120.fits from set of files +

    Subtract dark120.fits from set of files halley_*.fits (backup originals as halley_*.fits~):

    $ munipack phcorr -dark dark120.fits halley_*.fits -

    Subtract dark120.fits from set of files +

    Subtract dark120.fits from set of files halley_*.fits and store results in /tmp directory:

    @@ -293,4 +294,3 @@ - diff -Nru munipack-0.5.9/doc/man_setup.shtml munipack-0.5.10/doc/man_setup.shtml --- munipack-0.5.9/doc/man_setup.shtml 2017-07-17 23:03:48.000000000 +0000 +++ munipack-0.5.10/doc/man_setup.shtml 2018-01-16 17:58:03.000000000 +0000 @@ -58,6 +58,7 @@ FITS_KEY_AIRMASSAIRMASSairmass FITS_KEY_DATEOBSDATE-OBSthe start of exposure FITS_KEY_OBJECTOBJECTthe object identifier +FITS_KEY_IMAGETYPIMAGETYPimagetyp: light, flat, dark FITS_KEY_SATURATESATURATEdetector saturation (full well capacity) on ADU FITS_KEY_READNOISEREADNSread noise in ADU FITS_KEY_GAINGAINamplifier gain in electrons per ADU @@ -68,8 +69,6 @@ - - diff -Nru munipack-0.5.9/doc/man_votable.shtml munipack-0.5.10/doc/man_votable.shtml --- munipack-0.5.9/doc/man_votable.shtml 2017-07-17 23:03:48.000000000 +0000 +++ munipack-0.5.10/doc/man_votable.shtml 2018-01-16 17:58:04.000000000 +0000 @@ -24,10 +24,10 @@

    Description

    -VOTable file format is -a kind of XML format. One is used -as the primary data exchange format within -Virtual Observatory. +VOTable file format is +a kind of XML format. One is used +as the primary data exchange format within +Virtual Observatory. VOTable file is a text file with defined marks. The marks provides a tool for describe of a structure of data (tables, for example). VOTable format is designed for inter-process communication (in client — server model). @@ -41,10 +41,10 @@

  • The primary goal is conversion of VO catalogues to FITS tables
  • Conversion to the plain text format can be very useful for any additional processing by using conventional tools (text editors, utilities like awk, etc.).
  • -
  • Conversion to CSV +
  • Conversion to CSV format can be useful for users familiar with a spreadsheet-like utilities.
  • -
  • VOTable as a XML can be easy converted to - SVG +
  • VOTable as a XML can be easy converted to + SVG (another XML based file format) for drawing. Specially, it is for drawing of star charts.
  • @@ -65,9 +65,11 @@
    -s
    sort by the column
    -pt
    select projection: gnomonic
    -
    -pa
    Right Ascension of projection centre
    -
    -pd
    Declination of projection centre
    -
    -ps
    scale of projection
    +
    -pa
    Right Ascension of projection centre [deg]
    +
    -pd
    Declination of projection centre [deg]
    +
    -pw
    Canvas width [pix]
    +
    -ph
    Canvas height [pix]
    +
    -ps
    scale of projection [pix/deg]
    -ml
    magnitude limit
    --col-mag
    magnitude field key
    --col-ra
    Right Ascension field key
    @@ -76,14 +78,14 @@

    -See Common options for +See Common options for input/output filenames.

    Examples

    -As a preparation step, download VOTable from Virtual Observatory +As a preparation step, download VOTable from Virtual Observatory (use cone search):

    @@ -127,4 +129,3 @@ - diff -Nru munipack-0.5.9/doc/munipack-atom.py munipack-0.5.10/doc/munipack-atom.py --- munipack-0.5.9/doc/munipack-atom.py 2017-07-17 23:03:48.000000000 +0000 +++ munipack-0.5.10/doc/munipack-atom.py 2018-01-16 17:58:04.000000000 +0000 @@ -35,8 +35,9 @@ record("0.5.5",link,"Nights Without Convergence",2014,04,01), record("0.5.6",link,"Photon Calibration",2015,01,05), record("0.5.7",link,"Growth Curve",2016,10,25), - record("0.5.8",link,"Artificial Sky",2017,07,14) - record("0.5.9",link,"Artificial Sky",2017,07,18) + record("0.5.8",link,"Artificial Sky",2017,07,14), + record("0.5.9",link,"Artificial Sky",2017,07,18), + record("0.5.10",link,"Flat-fielding",2018,01,16) ] for r in records: diff -Nru munipack-0.5.9/doc/munipack.css munipack-0.5.10/doc/munipack.css --- munipack-0.5.9/doc/munipack.css 2017-07-17 23:03:48.000000000 +0000 +++ munipack-0.5.10/doc/munipack.css 2018-01-16 17:58:03.000000000 +0000 @@ -1,4 +1,4 @@ -body { font-size:100%; font-family: serif; width:50em; margin-left: auto; margin-right: auto; margin-top: 0; } +body { font-size:100%; font-family: serif; max-width:50em; margin-left: auto; margin-right: auto; margin-top: 0; } h1 { font-size: 1.4em; font-weight: bold; font-family: sans-serif; margin-right: 0; padding-left: 0; margin-top: 0; border-top: 1em; color: #8AB8E6; padding-top: 0.5em; } h2 { font-size: 1em; margin-top: 2em; font-weight: bold; font-family: sans-serif; border-bottom: thin dotted #8AB8E6; color: #8AB8E6;} h2.ttop { margin-top: 0; } diff -Nru munipack-0.5.9/doc/munipack.shtml munipack-0.5.10/doc/munipack.shtml --- munipack-0.5.9/doc/munipack.shtml 2017-07-17 23:03:48.000000000 +0000 +++ munipack-0.5.10/doc/munipack.shtml 2018-01-16 17:58:03.000000000 +0000 @@ -3,8 +3,8 @@ - @@ -24,13 +24,13 @@ Photometrical calibration with Munipack -For theoretical background see the book +For theoretical background see the book -Astronomy Methods: A Physical Approach to Astronomical Observations +Astronomy Methods: A Physical Approach to Astronomical Observations by Hale Bradt. -We are starting from that property of +We are starting from that property of CCD detectors which are photon detectors. That mean that these detect and stores directly photons. @@ -40,7 +40,7 @@ electronics. These devices gives a signal in data numbes dn (sometimes in units ADU or DN). With knowledcke og gain factor of electonic, the count of captured -photons cts is +photons cts is cts = dn [ADU] * gain [e-/ADU] [e-, photons] @@ -87,7 +87,7 @@ frequency (or wavelength) λeff and with half-with Δλ. The tabulated values of fluxes are given in a spectral flux normalized per -unit frequency or wavelength +unit frequency or wavelength f0 [W/m2/Hz] @@ -114,7 +114,7 @@ More importnat is that the efficinecy η can be appreciated also as the calibration factor -from our instumental count of photons to +from our instumental count of photons to a calibrated numbers of photons. From numerical pouint of view, the values of η @@ -147,7 +147,7 @@ f(cal) = c(cal) (h νeff) / Δν [W/m2/Hz] (note [W] = [J/s]). (add errors determination, -c has Possion and othesr gaussian distributions). +c has Possion and othesr gaussian distributions). The flux is used to describe total flux of objects @@ -193,14 +193,14 @@ provided tables and get values of Δν and νeff. Both can be specified from command line. -* The reference id of the photometric catalogue is given by EXTNAME +* The reference id of the photometric catalogue is given by EXTNAME keyword in reference table. (optional, rewrite from coommand line). * The reference catalogui contains magnitudes, the fluxes are computed as f = f0*10**(0.4*m) where f0 is flux per unit time, area and frequnecy and the provided calibratuion tables are searched for f0. -* The calibration parameter η(cal) is coded as FOTCAL +* The calibration parameter η(cal) is coded as FOTCAL (photon-calibrate rather than flux-calibrate prefering greek spelling). diff -Nru munipack-0.5.9/doc/rpmbuilder.shtml munipack-0.5.10/doc/rpmbuilder.shtml --- munipack-0.5.9/doc/rpmbuilder.shtml 2017-07-17 23:03:48.000000000 +0000 +++ munipack-0.5.10/doc/rpmbuilder.shtml 2018-01-16 17:58:03.000000000 +0000 @@ -10,7 +10,7 @@

    This page decribes how to prepare binary package for RPM-based distributions (Fedora, RHELL), by the ordinary way. -Building of package follows basic rules in +Building of package follows basic rules in How to create an RPM package.

    @@ -32,12 +32,12 @@
  • Mercurial, the version control system (optional)
  • -

    Required tools could be installed by the command (valid for Fedora 21, +

    Required tools could be installed by the command (valid for Fedora 21, modify to satisfy your needs):

     # yum install fedora-packager gcc-gfortran gcc-c++ libgfortran-static libstdc++-static cfitsio-devel ImageMagick autoconfig automake wxGTK3-devel
     
    -

    A lot of dependencies will be requested. Imagemagic is installed by default. +

    A lot of dependencies will be requested. Imagemagic is installed by default. The lib...-static are added because ones are not included in devel packages directly.

    @@ -52,7 +52,7 @@

    Download latest Munipack: -ftp://munipack.physics.muni.cz/pub/munipack/munipack-0.5.7.tar.gz +ftp://munipack.physics.muni.cz/pub/munipack/ and place it in ~/rpmbuild/SOURCES directory.

    @@ -65,7 +65,7 @@

    -When the build finished sucessfully, the packages in +When the build finished sucessfully, the packages in ~/rpmbuild/RPMS/<ARCH>/ are ready to install. Their installation is strightforward:

    Binary files /tmp/tmpIsR5ah/LGkvHlXPpo/munipack-0.5.9/doc/Screenshot-barnard_07R-mini.png and /tmp/tmpIsR5ah/a0pF0kjEWv/munipack-0.5.10/doc/Screenshot-barnard_07R-mini.png differ Binary files /tmp/tmpIsR5ah/LGkvHlXPpo/munipack-0.5.9/doc/Screenshot-channels-mini.png and /tmp/tmpIsR5ah/a0pF0kjEWv/munipack-0.5.10/doc/Screenshot-channels-mini.png differ Binary files /tmp/tmpIsR5ah/LGkvHlXPpo/munipack-0.5.9/doc/Screenshot-cli-mini.png and /tmp/tmpIsR5ah/a0pF0kjEWv/munipack-0.5.10/doc/Screenshot-cli-mini.png differ Binary files /tmp/tmpIsR5ah/LGkvHlXPpo/munipack-0.5.9/doc/Screenshot-Coloring-mini.png and /tmp/tmpIsR5ah/a0pF0kjEWv/munipack-0.5.10/doc/Screenshot-Coloring-mini.png differ Binary files /tmp/tmpIsR5ah/LGkvHlXPpo/munipack-0.5.9/doc/Screenshot-colors-mini.png and /tmp/tmpIsR5ah/a0pF0kjEWv/munipack-0.5.10/doc/Screenshot-colors-mini.png differ Binary files /tmp/tmpIsR5ah/LGkvHlXPpo/munipack-0.5.9/doc/Screenshot-gnumeric-mini.png and /tmp/tmpIsR5ah/a0pF0kjEWv/munipack-0.5.10/doc/Screenshot-gnumeric-mini.png differ Binary files /tmp/tmpIsR5ah/LGkvHlXPpo/munipack-0.5.9/doc/Screenshot-InstrMagnitude-mini.png and /tmp/tmpIsR5ah/a0pF0kjEWv/munipack-0.5.10/doc/Screenshot-InstrMagnitude-mini.png differ Binary files /tmp/tmpIsR5ah/LGkvHlXPpo/munipack-0.5.9/doc/Screenshot-m27_R-mini.png and /tmp/tmpIsR5ah/a0pF0kjEWv/munipack-0.5.10/doc/Screenshot-m27_R-mini.png differ Binary files /tmp/tmpIsR5ah/LGkvHlXPpo/munipack-0.5.9/doc/Screenshot-nite-mini.png and /tmp/tmpIsR5ah/a0pF0kjEWv/munipack-0.5.10/doc/Screenshot-nite-mini.png differ Binary files /tmp/tmpIsR5ah/LGkvHlXPpo/munipack-0.5.9/doc/Screenshot-Photometry-mini.png and /tmp/tmpIsR5ah/a0pF0kjEWv/munipack-0.5.10/doc/Screenshot-Photometry-mini.png differ Binary files /tmp/tmpIsR5ah/LGkvHlXPpo/munipack-0.5.9/doc/Screenshot-View-mini.png and /tmp/tmpIsR5ah/a0pF0kjEWv/munipack-0.5.10/doc/Screenshot-View-mini.png differ Binary files /tmp/tmpIsR5ah/LGkvHlXPpo/munipack-0.5.9/doc/Screenshot-Workplace-mini.png and /tmp/tmpIsR5ah/a0pF0kjEWv/munipack-0.5.10/doc/Screenshot-Workplace-mini.png differ Binary files /tmp/tmpIsR5ah/LGkvHlXPpo/munipack-0.5.9/doc/title_logo.png and /tmp/tmpIsR5ah/a0pF0kjEWv/munipack-0.5.10/doc/title_logo.png differ diff -Nru munipack-0.5.9/doc/wrinkledflat.svg munipack-0.5.10/doc/wrinkledflat.svg --- munipack-0.5.9/doc/wrinkledflat.svg 1970-01-01 00:00:00.000000000 +0000 +++ munipack-0.5.10/doc/wrinkledflat.svg 2018-01-16 17:58:04.000000000 +0000 @@ -0,0 +1,127 @@ + + + + diff -Nru munipack-0.5.9/doc/wrinkledflat.tex munipack-0.5.10/doc/wrinkledflat.tex --- munipack-0.5.9/doc/wrinkledflat.tex 1970-01-01 00:00:00.000000000 +0000 +++ munipack-0.5.10/doc/wrinkledflat.tex 2018-01-16 17:58:03.000000000 +0000 @@ -0,0 +1,27 @@ +% +% $ pdflatex -shell-escape wrinkledflat.tex +% +\documentclass[tikz,convert={outfile=wrinkledflat.svg}]{standalone} +\begin{document} +\begin{tikzpicture} + \definecolor{modra}{rgb}{0.541,0.722,0.902} + \begin{scope}[rotate=90] + \draw[ultra thin] (1,0) -- (3,0); + \draw[ultra thin] (1,1) -- (3,1); + + \draw[dashed] (2.28,8) -- (2.28,1.05); + \draw[dashed] (1.84,5) -- (1.84,1.05); + + \draw[thick,modra] (2,3) .. controls (1,4) and (3,7) .. (2,10); + \draw[densely dotted,domain=1.5:3, samples=256] plot(\x,{7+exp(-(\x-2.28)^2/2/0.1^2)}); + \draw[domain=1.3:2.5, samples=256] plot(\x,{4+exp(-(\x-1.84)^2/2/0.1^2)}); + + \draw[densely dotted,domain=1.5:3, samples=256] plot(\x,{1.05+0.9*exp(-(\x-2.28)^2/2/0.1^2)}); + \draw[domain=1.3:2.5, samples=256] plot(\x,{1.05+0.9*exp(-(\x-1.84)^2/2/0.1^2)}); + + \draw[domain=1:3, samples=256, modra] plot(\x,{0.05+0.6*exp(-(\x-1.8)^2/2/0.1^2)+ + 0.6*exp(-(\x-2.3)^2/2/0.2^2)}); + +\end{scope} +\end{tikzpicture} +\end{document} diff -Nru munipack-0.5.9/fitsut/Makefile.in munipack-0.5.10/fitsut/Makefile.in --- munipack-0.5.9/fitsut/Makefile.in 2017-07-17 23:04:25.000000000 +0000 +++ munipack-0.5.10/fitsut/Makefile.in 2018-01-16 17:58:15.000000000 +0000 @@ -274,7 +274,6 @@ builddir = @builddir@ datadir = @datadir@ datarootdir = @datarootdir@ -develop = @develop@ docdir = @docdir@ dvidir = @dvidir@ exec_prefix = @exec_prefix@ diff -Nru munipack-0.5.9/include/version.h munipack-0.5.10/include/version.h --- munipack-0.5.9/include/version.h 2017-07-17 23:03:48.000000000 +0000 +++ munipack-0.5.10/include/version.h 2018-01-16 17:58:04.000000000 +0000 @@ -3,7 +3,7 @@ Munipack - Copyright © 2009-2017 F.Hroch (hroch@physics.muni.cz) + Copyright © 2009-2018 F.Hroch (hroch@physics.muni.cz) This file is part of Munipack. @@ -29,10 +29,10 @@ #define INFOTEXT PACKAGE_NAME #define HOMEPAGE PACKAGE_URL -#define COPYLEFT L"© 1997-2017 " EMAIL +#define COPYLEFT L"© 1997-2018 " EMAIL #ifdef DEVELBUILD -#define DVERSION "\n DEVELOPMENT VERSION (build: " DATEBUILD ")" +#define DVERSION "\n DEVELOPMENT VERSION (build: " DATEBUILD ")\n" #else #define DVERSION "" #endif diff -Nru munipack-0.5.9/include/votable.h munipack-0.5.10/include/votable.h --- munipack-0.5.9/include/votable.h 2017-07-17 23:03:48.000000000 +0000 +++ munipack-0.5.10/include/votable.h 2018-01-16 17:58:04.000000000 +0000 @@ -1,9 +1,9 @@ -/* +/* VOTable parser - Copyright © 2010 - 2013 F.Hroch (hroch@physics.muni.cz) + Copyright © 2010 - 2013, 17 F.Hroch (hroch@physics.muni.cz) This file is part of Munipack. @@ -11,12 +11,12 @@ it under the terms of the GNU General Public License as published by the Free Software Foundation, either version 3 of the License, or (at your option) any later version. - + Munipack is distributed in the hope that it will be useful, but WITHOUT ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the GNU General Public License for more details. - + You should have received a copy of the GNU General Public License along with Munipack. If not, see . @@ -183,12 +183,12 @@ int RecordCount() const; std::vector GetRecord(int) const; std::vector GetColumn(int) const; - + // interface for programmers void SetProjection(const wxString&); void SetProjectionCenter(double,double); - void SetSize(double); + void SetCanvasSize(long,long); void SetScale(double); void SetMaglim(double); void SetMagkey(const wxString&); @@ -212,7 +212,7 @@ wxString proj_type, mag_key, alpha_key, delta_key; double proj_alpha, proj_delta, proj_scale, mag_limit; - double canvas_size; + long canvas_width, canvas_height; int timeout; // network timeout in seconds @@ -230,5 +230,6 @@ wxString GetString(const wxString&); double GetDouble(const wxString&); +long GetLong(const wxString&); bool GetBool(const wxString&); void GetOutput(const wxString&, wxString&, wxString&); diff -Nru munipack-0.5.9/kombine/kombine.f95 munipack-0.5.10/kombine/kombine.f95 --- munipack-0.5.9/kombine/kombine.f95 2017-07-17 23:03:48.000000000 +0000 +++ munipack-0.5.10/kombine/kombine.f95 2018-01-16 17:58:04.000000000 +0000 @@ -38,6 +38,7 @@ use fitsio use astrotrafo use phio + use iso_fortran_env implicit none @@ -45,7 +46,7 @@ real(dbl), parameter :: rad = 57.295779513082322865_dbl Character(len=*), parameter :: version = & - 'KOMBINE Version 0.6.x, (C)1998-2006,2011-6 F.Hroch, Masaryk University,Brno,CZ ' + 'KOMBINE 0.6.x, (C)1998-2006,2011-7 F.Hroch, Masaryk University,Brno,CZ ' ! Minimum of values real :: minvalue = 0.0 @@ -58,7 +59,9 @@ EXPTIME='EXPTIME',OBJECT='OBJECT',KEY_GAIN = FITS_KEY_GAIN real, dimension(:,:), allocatable :: KOMBINE, IMAGE, EXPMASK - real :: oneexp, etime, gain + real, dimension(:,:,:), allocatable :: frames + real, dimension(:), allocatable :: skies, exptimes + real :: oneexp, etime, gain, ctph, skymean real :: f,fs,sky,dsky real(dbl) :: ff,x,y,a,d character(len=FLEN_VALUE) :: onedate, obj, filtr, ctype1, ctype2 @@ -68,7 +71,8 @@ character(len=3*FLEN_FILENAME) :: buf character(len=FLEN_COMMENT) :: comgain logical :: init = .false., init_proj = .false., init_crval = .false., & - init_crpix = .false., init_scale=.false., init_angle=.false. + init_crpix = .false., init_scale=.false., init_angle=.false., & + reflex = .false., init_reflex = .false., sky_determine = .true. type(AstroTrafoProj) :: tp,tpi character(len=FLEN_VALUE) :: ptype = "GNOMONIC" real(dbl) :: xcen,ycen @@ -81,7 +85,7 @@ ! selection of method of interpolation ! 0=no interpolation, 1=bilinear, 2=bicubic, 3=bspline - ! fast slow slower hung up + ! fast slow slower hang up ! pixelized good perfect little bit over perfect integer :: sint = 2 @@ -97,6 +101,9 @@ ! use exposure mask logical :: expomask = .false. + ! output image is computed by robust mean, by default + logical :: average = .false. + ! Time start of first exposure character(len=FLEN_VALUE) :: first = '' @@ -169,6 +176,11 @@ read(val,*) angle init_angle = .true. + else if( key == 'REFLEX' ) then + + read(val,*) reflex + init_reflex = .true. + else if( key == 'CRVAL' ) then read(val,*) xcrval @@ -203,10 +215,14 @@ read(val,*) expomask + else if( key == 'AVERAGE' ) then + + read(val,*) average + else if( key == 'NFILES' ) then read(val,*) nfiles - allocate(alldate(nfiles)) + allocate(alldate(nfiles),skies(nfiles),exptimes(nfiles)) else if( key == 'FILE' ) then @@ -214,6 +230,7 @@ read(val,*) sb + sky_determine = .true. status = 0 Call ftdopn(25,sb,0,status) Call ftghpr(25,2,simple,bpix,naxis,naxes,pcount,gcount,extend,status) @@ -246,7 +263,8 @@ call wcsget(25,tpi,status) if( status == KEYWORD_NOT_FOUND ) then - write(*,'(a)') "Skipping `"//trim(sb)//"': astrometry calibration not found." + write(*,'(a)') & + "Skipped `"//trim(sb)//"': astrometry calibration not found." status = 0 goto 665 end if @@ -256,10 +274,43 @@ call FTG2DE(25,1,minvalue,naxes(1),naxes(1),naxes(2),IMAGE,anyf,status) if( status /= 0 ) goto 666 - call rmean(pack(IMAGE(1:size(IMAGE,1):10,1:size(IMAGE,2):10),.true.),sky,dsky) + ! + if( average ) then + ! move to photometry table + call ftmnhd(25,BINARY_TBL,PHOTOEXTNAME,0,status) + if( status == BAD_HDU_NUM ) then + write(*,'(a)') "Skipped `"//trim(sb)// & + "': Failed to find a photometry extension." + status = 0 + goto 665 + end if + call ftgkye(25,FITS_KEY_CTPH,ctph,buf,status) + if( status /= 0 ) then + write(*,'(a)') "Skipped `"//trim(sb)// & + "': Failed to find CTPH in the photometry extension." + status = 0 + endif + call ftgkye(25,FITS_KEY_SKYMEAN,skymean,buf,status) + if( status /= 0 ) then + write(*,'(a)') "Skipped `"//trim(sb)// & + "': Failed to find SKYMEAN in the photometry extension." + status = 0 + else + ! per pixel (arcsec originally) + sky = skymean * (3600*real(tpi%scale))**2 + sky_determine = .false. + endif + + end if - if( adjustsky) IMAGE = IMAGE - sky + if( sky_determine ) then + call rmean(pack(IMAGE(1:size(IMAGE,1):10,1:size(IMAGE,2):10),& + .true.),sky,dsky) +! else +! sky = skymean + end if + if( adjustsky ) IMAGE = IMAGE - sky ! first image - initialisation if( .not. init ) then @@ -274,6 +325,14 @@ ny = naxes(2) endif + if( average ) then + allocate(frames(nx,ny,nfiles),stat=status,errmsg=buf) + if( status /= 0 ) then + if( verbose ) write(error_unit,*) 'kombine:',trim(buf) + stop 'Failed to allocate memmory.' + end if + end if + allocate(KOMBINE(nx,ny),EXPMASK(nx,ny)) KOMBINE = 0.0 EXPMASK = 0.0 @@ -309,6 +368,15 @@ else tp%rot = tpi%rot end if + if( init_reflex )then + if( reflex ) then + tp%refl = -1.0_dbl + else + tp%refl = 1.0_dbl + end if + else + tp%refl = tpi%refl + end if tp%err = tpi%err call trafo_refresh(tp) @@ -320,6 +388,11 @@ call bspline_init(IMAGE) endif + n = n + 1 + write(alldate(n),*) "'",trim(sb),"' ",sky + skies(n) = sky + exptimes(n) = oneexp + ! compute sumation do i = 1, nx do j = 1, ny @@ -329,19 +402,21 @@ call invtrafo(tp,x,y,a,d) ff = skyinterpol(sint,a,d,IMAGE,tpi,xrange) - KOMBINE(i,j) = KOMBINE(i,j) + real(ff) + if( average ) then + frames(i,j,n) = real(ff) - sky + else + KOMBINE(i,j) = KOMBINE(i,j) + real(ff) + end if - if( oneexp > 0.0 .and. xrange ) EXPMASK(i,j) = EXPMASK(i,j) + oneexp + if( oneexp > 0.0 .and. xrange ) & + EXPMASK(i,j) = EXPMASK(i,j) + oneexp enddo enddo if( sint == 3 ) then call bspline_shutdown endif - n = n + 1 - write(alldate(n),*) "'",trim(sb),"' ",sky if( first == '' ) first = onedate - if( oneexp > 0.0 ) etime = etime + oneexp 665 continue @@ -358,9 +433,21 @@ enddo 20 continue - if( n == 0 ) stop 'No input image.' + if( n == 0 ) stop 'No input images.' nfiles = n + if( average ) then + call rmean(skies(1:nfiles),skymean,dsky) + do i = 1, nx + do j = 1, ny + call rmean(frames(i,j,1:n),f,fs) + kombine(i,j) = f*n + skymean + end do + end do + deallocate(frames) + end if + + if( expomask ) then where( EXPMASK /= 0.0 ) KOMBINE = KOMBINE / EXPMASK @@ -390,7 +477,12 @@ endif Call ftukys(26,OBJECT,obj,'',status) Call ftukys(26,FILTER,filtr,'',status) - call ftukye(26,EXPTIME,etime,10,'Sum of all exposure times',status) + if( average ) then + call rmean(exptimes(1:nfiles),etime,oneexp) + call ftukye(26,EXPTIME,etime,10,'Average exposure time',status) + else + call ftukye(26,EXPTIME,etime,10,'Sum of all exposure times',status) + end if if( first /= '' ) call ftukys(26,DATE_OBS,first,'UTC of series exposure start',status) if( gain > 0.0 ) call ftukye(26,FITS_KEY_GAIN,gain,7,comgain,status) @@ -447,6 +539,11 @@ case(3) buf = 'Bspline interpolation has been used.' end select + if( average ) then + call ftpcom(26,'Frames has been averaged by robust mean.',status) + else + call ftpcom(26,'Frames has been summed.',status) + end if call ftpcom(26,buf,status) call ftpcom(26,version,status) if( status /= 0 ) goto 666 @@ -474,7 +571,7 @@ 666 continue if( allocated(KOMBINE) ) deallocate(KOMBINE) if( allocated(EXPMASK) ) deallocate(EXPMASK) - if( allocated(alldate) ) deallocate(alldate) + if( allocated(alldate) ) deallocate(alldate,skies) if( status == 0 )then stop 0 @@ -505,7 +602,8 @@ j = nint(y) ! write(*,*) a,d,x,y - if( 1 <= i .and. i <= size(array,1) .and. 1 <= j .and. j <= size(array,2)) then + if( 1 <= i .and. i <= size(array,1) .and. & + 1 <= j .and. j <= size(array,2) ) then select case (sint) case(0) diff -Nru munipack-0.5.9/kombine/Makefile.in munipack-0.5.10/kombine/Makefile.in --- munipack-0.5.9/kombine/Makefile.in 2017-07-17 23:04:25.000000000 +0000 +++ munipack-0.5.10/kombine/Makefile.in 2018-01-16 17:58:15.000000000 +0000 @@ -267,7 +267,6 @@ builddir = @builddir@ datadir = @datadir@ datarootdir = @datarootdir@ -develop = @develop@ docdir = @docdir@ dvidir = @dvidir@ exec_prefix = @exec_prefix@ diff -Nru munipack-0.5.9/lib/astrosphere.f95 munipack-0.5.10/lib/astrosphere.f95 --- munipack-0.5.9/lib/astrosphere.f95 2017-07-17 23:03:48.000000000 +0000 +++ munipack-0.5.10/lib/astrosphere.f95 2018-01-16 17:58:04.000000000 +0000 @@ -62,13 +62,13 @@ ! local sidereal time in hours ! ! jd is a full Julian date -! lamda is a longitude in degrees, -west... +east +! lamda is a longitude in degrees, +west... -east ! ! The precision is better than 1 second. ! According to Astronomical Almanac 2000. - lmst = mod(gmst(jd) - longitude/15.0_db,24.0_db) + lmst = mod(gmst(jd) + longitude/15.0_db,24.0_db) end function lmst diff -Nru munipack-0.5.9/lib/escale.f95 munipack-0.5.10/lib/escale.f95 --- munipack-0.5.9/lib/escale.f95 2017-07-17 23:03:48.000000000 +0000 +++ munipack-0.5.10/lib/escale.f95 2018-01-16 17:58:03.000000000 +0000 @@ -65,40 +65,82 @@ ! Normally, the value is expected near number one: escale ~= 1. use fmm + use medians real(dbl), dimension(:), intent(in) :: r real(dbl), intent(in out) :: s logical, intent(out), optional :: reliable - real(dbl) :: stol, smin, smax, e - integer :: n + ! golden ratio + real(dbl), parameter :: gold = 1.618 !=(1 + sqrt(5))/2 + real(dbl) :: stol, smin, smax, e, valmin, valmax + integer :: n, iter + logical :: abovemin, undermax + + if( s <= 0 ) then + reliable = .false. + return + end if n = size(r) allocate(res(n),rho(n)) res = r + valmin = max(minval(abs(res)),epsilon(res)) + valmax = maxval(abs(res)) - if( n > 23 ) then + if( n > 13 ) then ! we belives that the initial estimate of s is very good, ! and it falls inside the interval gived by golden ratio. - smin = s / 1.618 - smax = s * 1.618 + smin = max(s / gold, valmin) + smax = min(s * gold, valmax) stol = max(etol*s,100*epsilon(s)) ! The maximum will be located with the precision ! giving approx ln((smax - smin)/stol) calls to negentropy. + abovemin = abs(valmin - smin) > epsilon(smin) + undermax = abs(valmax - smax) > epsilon(smax) + else ! A case of a few elements only .. there is many local extremes... ! we are selecting one from those, randomly... - smin = minval(abs(res)) - smax = maxval(abs(res)) - stol = max(etol*smax,100*epsilon(s)) + smin = valmin + smax = valmax + stol = max(etol*valmin,100*epsilon(s)) + abovemin = .false. + undermax = .false. end if - s = fmin(smin,smax,negentropy,stol) + do iter = 1, 3 + + if( smax > smin ) then + s = fmin(smin,smax,negentropy,stol) + else ! if( smin == smax) then + s = smin + + ! yes, it is possible for two sets of identical values + end if + +! write(*,*) smin, smax, abovemin, undermax, iter + + ! update initial range if needed, or accept result + e = 2*stol + if( abs(s - smin) < e .and. abovemin ) then + smin = max(smin / gold, valmin) + abovemin = abs(valmin - smin) > epsilon(smin) +! write(*,*) 'smin=',smin,smax,iter,abovemin, undermax + else if( abs(smax - s) < e .and. undermax ) then + smax = min(smax * gold, valmax) + undermax = abs(valmax - smax) > epsilon(smax) +! write(*,*) 'smax=',smax,smin,iter,abovemin, undermax + else + exit + end if + + end do if( present(reliable) ) then e = 2*stol @@ -123,7 +165,7 @@ ! call iandrews(res/s,rho) ! rho = (res/s)**2/2 - negentropy = - sum(rho*exp(-2*rho), rho < rhomax) / count(rho < rhomax) + negentropy = - sum(rho*exp(-2.12*rho), rho < rhomax) / count(rho < rhomax) ! negentropy = - sum(rho*exp(-2*rho)) / size(rho) ! The sum includes only values inside range acceptable for exp() function. diff -Nru munipack-0.5.9/lib/fitsio.f95 munipack-0.5.10/lib/fitsio.f95 --- munipack-0.5.9/lib/fitsio.f95 2017-07-17 23:03:48.000000000 +0000 +++ munipack-0.5.10/lib/fitsio.f95 2018-01-16 17:58:04.000000000 +0000 @@ -1,7 +1,7 @@ ! ! FITSIO definitions - directly derived from f77.inc ! -! Copyright © 2010-7 F.Hroch (hroch@physics.muni.cz) +! Copyright © 2010-8 F.Hroch (hroch@physics.muni.cz) ! ! This file is part of Munipack. ! @@ -25,9 +25,9 @@ ! version identification character(len=*), parameter :: MUNIPACK_VERSION = & - "Munipack 0.5.9, (C)1997-2017 F. Hroch " + "Munipack 0.5.10, (C)1997-2018 F. Hroch " - character(len=*), parameter :: FITS_VALUE_CREATOR = "Munipack 0.5.9" + character(len=*), parameter :: FITS_VALUE_CREATOR = "Munipack 0.5.10" character(len=*), parameter :: FITS_COM_CREATOR = "http://munipack.physics.muni.cz" ! basic constants (fitsio.h) diff -Nru munipack-0.5.9/lib/liblist.f95 munipack-0.5.10/lib/liblist.f95 --- munipack-0.5.9/lib/liblist.f95 2017-07-17 23:03:48.000000000 +0000 +++ munipack-0.5.10/lib/liblist.f95 2018-01-16 17:58:04.000000000 +0000 @@ -28,7 +28,7 @@ type ImageType integer :: i - real :: mean,stderr,exptime,temp,saturate + real :: mean,stderr,stdsig,exptime,temp,saturate real, pointer :: image(:,:), noise(:,:) character(len=FLEN_VALUE) :: dateobs, filter character(len=FLEN_FILENAME) :: filename @@ -69,12 +69,12 @@ !------------------------------------------------------------------------- - Subroutine AddItem (current,image,filename,noise,mean,stderr,dateobs,exptime, & - filter,temp,satur) + Subroutine AddItem (current,image,filename,noise,mean,stderr,stdsig,& + dateobs,exptime,filter,temp,satur) type(Imagetype), pointer :: current real, dimension(:,:), optional, pointer :: image, noise - real, optional, intent(in) :: mean, stderr, exptime, temp, satur + real, optional, intent(in) :: mean, stderr, stdsig, exptime, temp, satur character(len=*), optional, intent(in) :: filename,dateobs, filter integer :: i @@ -96,6 +96,7 @@ if( present(filename) ) current%filename = filename if( present(mean) ) current%mean = mean if( present(stderr) ) current%stderr = stderr + if( present(stdsig) ) current%stdsig = stdsig if( present(dateobs) ) current%dateobs = dateobs if( present(filter) ) current%filter = filter if( present(exptime) ) current%exptime = exptime @@ -106,12 +107,12 @@ ! ----------------------------------------------------------------------- - subroutine GetItem(current,image,noise,filename,mean,stderr,dateobs,exptime, & - filter,temp, satur) + subroutine GetItem(current,image,noise,filename,mean,stderr,stdsig, & + dateobs,exptime,filter,temp, satur) type(Imagetype) :: current real, dimension(:,:), optional, pointer :: image, noise - real, optional, intent(out) :: mean,stderr,exptime,temp,satur + real, optional, intent(out) :: mean,stderr,stdsig,exptime,temp,satur character(len=*), optional, intent(out) :: filename,dateobs,filter if( present(image) ) image => current%image @@ -119,6 +120,7 @@ if( present(filename) ) filename = current%filename if( present(mean) ) mean = current%mean if( present(stderr) ) stderr = current%stderr + if( present(stdsig) ) stdsig = current%stdsig if( present(dateobs) ) dateobs = current%dateobs if( present(exptime) ) exptime = current%exptime if( present(filter) ) filter = current%filter @@ -248,21 +250,23 @@ end subroutine PutPar - subroutine SetItem(current,array,filename,mean,stderr,dateobs,exptime,filter,temp,satur) + subroutine SetItem(current,array,filename,mean,stderr,stdsig, & + dateobs,exptime,filter,temp,satur) type(Imagetype) :: current real, dimension(:,:), optional, pointer :: array - real, optional, intent(out) :: mean,stderr,exptime,temp,satur - character(len=*), optional, intent(out) :: filename,dateobs,filter + real, optional, intent(in) :: mean,stderr,stdsig,exptime,temp,satur + character(len=*), optional, intent(in) :: filename,dateobs,filter - if( present(array) ) current%image => array - if( present(filename) )current%filename = filename - if( present(mean) ) current%mean = mean - if( present(stderr) ) current%stderr= stderr - if( present(dateobs) ) current%dateobs = dateobs - if( present(exptime) ) current%exptime = exptime - if( present(filter) ) current%filter = filter - if( present(temp) ) current%temp = temp + if( present(array) ) current%image => array + if( present(filename) ) current%filename = filename + if( present(mean) ) current%mean = mean + if( present(stderr) ) current%stderr= stderr + if( present(stdsig) ) current%stdsig= stdsig + if( present(dateobs) ) current%dateobs = dateobs + if( present(exptime) ) current%exptime = exptime + if( present(filter) ) current%filter = filter + if( present(temp) ) current%temp = temp if( present(satur) ) current%saturate = satur end subroutine SetItem diff -Nru munipack-0.5.9/lib/Makefile.in munipack-0.5.10/lib/Makefile.in --- munipack-0.5.9/lib/Makefile.in 2017-07-17 23:04:25.000000000 +0000 +++ munipack-0.5.10/lib/Makefile.in 2018-01-16 17:58:15.000000000 +0000 @@ -397,7 +397,6 @@ builddir = @builddir@ datadir = @datadir@ datarootdir = @datarootdir@ -develop = @develop@ docdir = @docdir@ dvidir = @dvidir@ exec_prefix = @exec_prefix@ diff -Nru munipack-0.5.9/lib/photoconv.f95 munipack-0.5.10/lib/photoconv.f95 --- munipack-0.5.9/lib/photoconv.f95 2017-07-17 23:03:48.000000000 +0000 +++ munipack-0.5.10/lib/photoconv.f95 2018-01-16 17:58:04.000000000 +0000 @@ -1,7 +1,7 @@ ! ! photoconv - photometry conversions ! -! Copyright © 2013 - 15 F.Hroch (hroch@physics.muni.cz) +! Copyright © 2013 - 15, 2017 F.Hroch (hroch@physics.muni.cz) ! ! This file is part of Munipack. ! @@ -9,12 +9,12 @@ ! it under the terms of the GNU General Public License as published by ! the Free Software Foundation, either version 3 of the License, or ! (at your option) any later version. -! +! ! Munipack is distributed in the hope that it will be useful, ! but WITHOUT ANY WARRANTY; without even the implied warranty of ! MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the ! GNU General Public License for more details. -! +! ! You should have received a copy of the GNU General Public License ! along with Munipack. If not, see . @@ -34,10 +34,10 @@ ! reciprocal flux for star of magnitude 25 real(dbl), parameter :: flux25 = 1e10 - ! spectral flux density for star of magnitude 0 in V (545nm) band for AB system + ! spectral flux density for star of magnitude 0 in V (545nm) band for AB system real(dbl), parameter :: ABspflux = 3.631e-23 ! [W/m2/Hz] - ! spectral flux density for star of magnitude 0 in V (545nm) band for ST system + ! spectral flux density for star of magnitude 0 in V (545nm) band for ST system real(dbl), parameter :: STspflux = 3.6335e-10 ! [W/m2/nm] ! gauss-hermite coefficients @@ -107,7 +107,7 @@ end subroutine quantity subroutine squantity(key,unit) - + ! quantity for surface photometry character(len=*), intent(in) :: key @@ -129,7 +129,7 @@ where( cts >= 0.0_dbl) rate = f*cts - drate = f*dcts + drate = sqrt(f)*dcts elsewhere rate = -1.0_dbl drate = -1.0_dbl @@ -150,7 +150,7 @@ where( ph >= 0.0_dbl) rate = ph/f - drate = dph/f + drate = dph/sqrt(f) elsewhere rate = -1.0_dbl drate = -1.0_dbl @@ -171,7 +171,7 @@ where( cts >= 0.0_dbl) ph = f*cts - dph = f*dcts + dph = sqrt(f)*dcts elsewhere ph = -1.0_dbl dph = -1.0_dbl @@ -192,7 +192,7 @@ where( ph >= 0.0_dbl ) phlam = f*ph - dphlam = f*dph + dphlam = sqrt(f)*dph elsewhere phlam = -1.0_dbl dphlam = -1.0_dbl @@ -213,7 +213,7 @@ where( ph >= 0.0_dbl ) phnu = f*ph - dphnu = f*dph + dphnu = sqrt(f)*dph elsewhere phnu = -1.0_dbl dphnu = -1.0_dbl @@ -235,7 +235,7 @@ where( ph >= 0.0_dbl ) flux = ph*f - dflux = dph*f + dflux = dph*sqrt(f) elsewhere flux = -1.0_dbl dflux = -1.0_dbl @@ -252,11 +252,11 @@ real(dbl), dimension(:), intent(out) :: flux,dflux real(dbl) :: f - f = planck * c / leff + f = planck * c / leff where( ph >= 0.0_dbl ) flux = ph*f - dflux = dph*f + dflux = dph*sqrt(f) elsewhere flux = -1.0_dbl dflux = -1.0_dbl @@ -266,7 +266,7 @@ subroutine cts2flux0(leff,cts,dcts,flux,dflux) ! replaced by ph2flux0 - + ! (light intensity, energy) flux integrated over frequency band [W/m2] real(dbl), intent(in) :: leff @@ -278,7 +278,7 @@ where( cts >= 0.0_dbl ) flux = f * cts - dflux = f * dcts + dflux = sqrt(f) * dcts elsewhere flux = -1.0_dbl dflux = -1.0_dbl @@ -299,7 +299,7 @@ where( ph >= 0.0_dbl ) flux = ph*f - dflux = dph*f + dflux = dph*sqrt(f) elsewhere flux = -1.0_dbl dflux = -1.0_dbl @@ -321,7 +321,7 @@ where( ph >= 0.0_dbl ) flux = ph*f - dflux = dph*f + dflux = dph*sqrt(f) elsewhere flux = -1.0_dbl dflux = -1.0_dbl @@ -342,7 +342,7 @@ where( ph >= 0.0_dbl ) flux = ph*f - dflux = dph*f + dflux = dph*sqrt(f) elsewhere flux = -1.0_dbl dflux = -1.0_dbl @@ -369,7 +369,7 @@ elsewhere dflux = 0 end where - + end subroutine mag2flux0 subroutine mag2ph(leff,lwidth,zeroflam,mag,dmag,ph,dph) @@ -409,7 +409,7 @@ ! dph = dmag*ph/1.0857 - ! + ! ! flux = e * zeroflux * 10.0_dbl**(-0.4_dbl * (mag - mag0)) ! write(*,*) real(zeroflam) @@ -490,7 +490,7 @@ ! n0 = (/4.34413517E+09,1.34928722E+10,8.57578752E+09,1.31331963E+10,9.31594240E+09/) w = (/0.572981,0.683449,0.76545,0.645865,0.634657/) - flux = flamref * 1e9 * 10.0_dbl**(-0.4_dbl * (mag - 0.04)) + flux = flamref * 1e9 * 10.0_dbl**(-0.4_dbl * (mag - 0.04)) flux(3) = 1e9 * flamref(3) * 10.0_dbl**(-0.4_dbl * mag(3)) * sqrtpi * lwidth(3)/2 * w(3) flux(2) = flux(3)*10**(-0.4*(mag(2)-mag(3)))*1.9644 !* (w(3)/w(2)) @@ -552,7 +552,7 @@ ! n0 = (/4.34413517E+09,1.34928722E+10,8.57578752E+09,1.31331963E+10,9.31594240E+09/) w = (/0.572981,0.683449,0.76545,0.645865,0.634657/) -! write(*,*) +! write(*,*) ! flux = zeroflux * 10.0_dbl**(-0.4_dbl * mag) ! flux = w * flux @@ -579,7 +579,7 @@ !!$ call mag2ph(leff,lwidth,zeroflux,mag,dmag,ph,dph) !!$ !!$ c = exptime * area -!!$ ph = c * ph +!!$ ph = c * ph !!$ dph = c *dph !!$ !!$ end subroutine mag2pht @@ -647,7 +647,7 @@ !!$ flam = w * flux / lw /sqrtpi * 1e-9 !!$ write(*,*) real(flam) !!$ -!!$! ph = zeroflux * leff * 10.0_dbl**(-0.4_dbl*mag) / hc +!!$! ph = zeroflux * leff * 10.0_dbl**(-0.4_dbl*mag) / hc !!$ !!$ do iter = 1,2 !!$ @@ -757,14 +757,14 @@ u2 = dd/(leff(i+1)-leff(i))/(leff(i+1)-leff(i-1)) flux(i) = ww*lw(i)*flam(i) + u1*flam(i-1) + u2*flam(i+1) end do - + hh = h0 + 2*h12 i = 1 t = (lw(i)*a)**2 df = (flam(i+1) - flam(i)) / (leff(i+1) - leff(i)) df1 = (flam(i+2) - flam(i+1)) / (leff(i+2) - leff(i+1)) flux(i) = hh*flam(i)*lw(i) - h12*t*lw(i)/(leff(i+2) - leff(i))*(df - df1) - + i = n t = (lw(i)*a)**2 df = (flam(i-1) - flam(i)) / (leff(i-1) - leff(i)) @@ -780,14 +780,14 @@ !!$ u2 = dd/(leff(i+1)-leff(i))/(leff(i+1)-leff(i-1)) !!$ flux(i) = ww*lw(i)*flam(i) + u1*flam(i-1) + u2*flam(i+1) !!$ end do -!!$ +!!$ !!$ hh = h0 + 2*h12 !!$ i = 1 !!$ t = (lw(i)*a)**2 !!$ df = (flam(i+1) - flam(i)) / (leff(i+1) - leff(i)) !!$ df1 = (flam(i+2) - flam(i+1)) / (leff(i+2) - leff(i+1)) !!$ flux(i) = hh*flam(i)*lw(i) + h12*t*lw(i)/(leff(i+2) - leff(i))*(df - df1) -!!$ +!!$ !!$ i = n !!$ t = (lw(i)*a)**2 !!$ df = (flam(i-1) - flam(i)) / (leff(i-1) - leff(i)) @@ -841,9 +841,9 @@ uu = leff(i)**2 + leff(i+1)*leff(i-1) - leff(i)*(leff(i+1)+leff(i-1)) + t2 u0 = 2*leff(i)*uu - 2*t2*(2*leff(i)-(leff(i+1)+leff(i-1))) u0 = u0 / (leff(i)-leff(i-1))/(leff(i)-leff(i+1)) - + ! write(*,*) u0,u1,u2 - + uu = lw(i) / hc d(j) = uu * (h0*leff(i) + h12*u0) if( j > 1 ) p(j) = h12 * u1 * uu @@ -852,7 +852,7 @@ if( j == m ) b(j) = b(j) - flam(i+1)*u2* uu * h12 ! write(*,*) d(j),p(j),s(j) - + end do ! write(*,*) real(d) @@ -875,7 +875,7 @@ dd = h12*t*u/(leff(i+1) - leff(i))*flam(i+1) + & h12*t*leff(i)/(leff(i+2) - leff(i))*df1 flam(i) = (wplux(i)*hc/lw(i) - dd)/ww - + i = n t = (a*lw(i))**2 df1 = (flam(i-2) - flam(i-1)) / (leff(i-2) - leff(i-1)) @@ -919,9 +919,9 @@ !!$ d(j) = h0*leff(i) + 2*h12*leff(i)*(1-t**2/u) & !!$ + 2*h12*t*(leff(i+1) + leff(i-1) - 2*leff(i))/u !!$ d(j) = d(j)*lw(i) / hc -!!$ +!!$ !!$ write(*,*) h0*leff(i),h12*leff(i)*(1-t**2/u),2*h12*t*(leff(i+1) + leff(i-1) - 2*leff(i))/u,u -!!$ +!!$ !!$ hh = 2*h12*lw(i)**3*a**2/(leff(i+1)-leff(i-1)) !!$ u1 = hh*(2*leff(i)-leff(i+1))/(leff(i) - leff(i-1)) !!$ u2 = hh*(2*leff(i)-leff(i-1))/(leff(i+1) - leff(i)) @@ -931,7 +931,7 @@ !!$ if( j == m ) b(j) = b(j) - flam(i+1)*u2 / hc / w(i+1) !!$ !!$ write(*,*) d(j),p(j),s(j) -!!$ +!!$ !!$ end do !!$ !!$! write(*,*) real(d) @@ -954,7 +954,7 @@ !!$ dd = h12*t*u/(leff(i+1) - leff(i))*flam(i+1) + & !!$ h12*t*leff(i)/(leff(i+2) - leff(i))*df1 !!$ flam(i) = (ph(i)*hc/lw(i) - dd)/ww -!!$ +!!$ !!$ i = n !!$ t = (a*lw(i))**2 !!$ df1 = (flam(i-2) - flam(i-1)) / (leff(i-2) - leff(i-1)) @@ -990,7 +990,7 @@ n = size(flam) do i = 2,n-1 - + t2 = (lw(i)*a)**2 u1 = 2*t2*(2*leff(i) - leff(i+1))/(leff(i-1)-leff(i))/(leff(i-1)-leff(i+1)) u2 = 2*t2*(2*leff(i) - leff(i-1))/(leff(i+1)-leff(i-1))/(leff(i+1)-leff(i)) @@ -1001,7 +1001,7 @@ plux3(i) = lw(i)*((h0*leff(i) + h12*u0)*flam(i)+h12*(u1*flam(i-1)+u2*flam(i+1))) end do - + i = 1 hh = h0 + 2*h12 t = (a*lw(i))**2 @@ -1088,20 +1088,20 @@ real(dbl), dimension(:), intent(out) :: ph,dph real(dbl) :: ph0 - ph0 = 1e9 * sqrtpi2 * lfwhm * flamref * leff / hc - + ph0 = 1e9 * sqrtpi2 * flamref * lfwhm * leff / hc + where( mag < 99 ) ph = ph0 * 10.0_dbl**(-0.4_dbl*mag) elsewhere ph = -1 end where - where( dmag < 9 ) + where( dmag < 9 .and. ph > 0 ) dph = ph * dmag / 1.0857 - elsewhere( dmag >= 9 .and. mag < 99 ) - dph = sqrt(ph) +! elsewhere( dmag >= 9 .and. mag < 99 ) +! dph = sqrt(ph) elsewhere - dph = 0 + dph = -1 end where end subroutine mag2ph0 @@ -1115,13 +1115,17 @@ real(dbl), dimension(:), intent(out) :: mag,dmag real(dbl) :: ph0 - ph0 = 1e9 * flamref * sqrtpi2 * lfwhm * leff / hc + ph0 = 1e9 * sqrtpi2 * flamref * lfwhm * leff / hc where( ph > 0.0_dbl ) - mag = - 2.5_dbl*log10(ph / ph0) - dmag = 1.086_dbl*dph/ph + mag = -2.5_dbl*log10(ph / ph0) elsewhere mag = 99.99999_dbl + end where + + where( dph > 0 .and. ph > 0.0_dbl ) + dmag = 1.086_dbl*dph/ph + elsewhere dmag = 9.99999_dbl end where @@ -1160,7 +1164,7 @@ !!$ call mag2ph(leff,lwidth,zeroflux,mag,dmag,ph,dph) !!$ !!$ c = exptime * area -!!$ ph = c * ph +!!$ ph = c * ph !!$ dph = c *dph !!$ !!$ end subroutine mag2pht0 @@ -1179,7 +1183,7 @@ integer :: i if( size(ph) == 1 ) then - + flux = hc / leff * ph mag = -2.5_dbl * log10(flux / flamref) @@ -1200,7 +1204,7 @@ det = 1 v = 1 + u*lw(i)**2/leff(i)*(1-(leff(i-1)/leff(i))**3*(ph(i-1)/ph(1))) flux(i) = ph(i)*v/leff(i)/det - + end do flux = hc * flux @@ -1274,7 +1278,7 @@ end where end subroutine flam2stmag - + subroutine ph2abmag(feff,ffwhm,ph,dph,mag,dmag) ! photons to AB-magnitudes @@ -1285,7 +1289,7 @@ real(dbl) :: f f = planck * (feff / ffwhm) / ABspflux - + where( ph > 0.0_dbl ) mag = - 2.5_dbl*log10(f*ph) dmag = 1.0857*dph/ph @@ -1317,14 +1321,14 @@ end subroutine ph2stmag - + ! solution of tri-diagonal system of linear equations subroutine tridig(d,p,s,b) real(dbl), dimension(:), intent(in out) :: d,p,s,b real(dbl) :: r integer :: i,k,n - + n = size(d) do i = 2,n @@ -1340,5 +1344,5 @@ end do end subroutine tridig - + end module photoconv diff -Nru munipack-0.5.9/lib/qmean.f95 munipack-0.5.10/lib/qmean.f95 --- munipack-0.5.9/lib/qmean.f95 2017-07-17 23:03:48.000000000 +0000 +++ munipack-0.5.10/lib/qmean.f95 2018-01-16 17:58:04.000000000 +0000 @@ -47,7 +47,7 @@ real(dbl), dimension(:), intent(in) :: x real(dbl), intent(out) :: t,s real(dbl), dimension(:), allocatable :: xcdf,ycdf - real(dbl), dimension(3), parameter :: xq = (/0.25, 0.5, 0.75/) + real(dbl), dimension(3), parameter :: xq = (/0.25_dbl, 0.5_dbl, 0.75_dbl/) real(dbl), dimension(size(xq)) :: q integer :: i,n @@ -96,7 +96,7 @@ real(dbl) :: h n = size(x) - h = 1.0 / (n + 1.0) + h = 1.0_dbl / (n + 1.0_dbl) u = x call qsort(u) diff -Nru munipack-0.5.9/lib/rline.f95 munipack-0.5.10/lib/rline.f95 --- munipack-0.5.9/lib/rline.f95 2017-07-17 23:03:48.000000000 +0000 +++ munipack-0.5.10/lib/rline.f95 2018-01-16 17:58:04.000000000 +0000 @@ -292,7 +292,7 @@ logical, intent(out) :: reli real(dbl), dimension(2,2) :: cov real(dbl) :: df, f2 - integer :: nprint,info + integer :: nprint,info, i if( debug ) then nprint = 1 @@ -329,8 +329,8 @@ cov = cov / rsig**2 sig = rsig * sqrt(f2/df*ndat/(ndat-2)) - da = sig * sqrt(cov(1,1)) - db = sig * sqrt(cov(2,2)) + if( cov(1,1) > 0 ) da = sig * sqrt(cov(1,1)) + if( cov(2,2) > 0 ) db = sig * sqrt(cov(2,2)) else reli = .false. diff -Nru munipack-0.5.9/lib/rmean.f95 munipack-0.5.10/lib/rmean.f95 --- munipack-0.5.9/lib/rmean.f95 2017-07-17 23:03:48.000000000 +0000 +++ munipack-0.5.10/lib/rmean.f95 2018-01-16 17:58:04.000000000 +0000 @@ -389,8 +389,8 @@ if( converge ) then f2 = sum(psi**2) if( df > 0 .and. f2 > 0 ) then - sig = s*sqrt(f2/df*n/(n-1)) - dt = sig / sqrt(df) + sig = s !* + dt = sig * sqrt(f2/df**2*n/(n-1)) end if end if @@ -1444,7 +1444,7 @@ d = 2*tol reli = abs(t - tmin) > d .and. abs(tmax - t) > d - ! results too close to endpoints looks very bad... + ! results lying too close to endpoints looks very bad... end subroutine zmean diff -Nru munipack-0.5.9/lib/robratio.f08 munipack-0.5.10/lib/robratio.f08 --- munipack-0.5.9/lib/robratio.f08 2017-07-17 23:03:48.000000000 +0000 +++ munipack-0.5.10/lib/robratio.f08 2018-01-16 17:58:03.000000000 +0000 @@ -62,7 +62,7 @@ ! verbose, updated by calling rcal() logical, private :: verbose = .false. - ! which method of estimate the ratio will be used? + ! which method of estimate of the ratio will be used? integer, parameter, private :: method = 2 ! debuging @@ -77,14 +77,18 @@ ! But, the pesimist, inside us, says that the convergence can be slower. ! Tolerances in numerical precision of iterations - real(dbl), parameter, private :: tol = 10*epsilon(0.0_dbl) + real(dbl), parameter, private :: tol = 10*epsilon(1.0_dbl) ! Limit for use of Poisson statistics (Normal otherwise) integer, parameter, private :: plimit = 666 + ! Parameter for regularisation + real(dbl), private :: reg + ! working arrays - real(dbl), dimension(:), allocatable, private :: cts,dcts,pht,dpht,res,dcts2,dpht2 - real(dbl), private :: xctph, hsig, rmin, rmax + real(dbl), dimension(:), allocatable, private :: cts,dcts,pht,dpht,res, & + dcts2,dpht2 + real(dbl), private :: xctph, sigma, rmin, rmax private :: fundif, funder, loglikely, residuals, residuals2, difjac, & jacobian_analytic, rnewton, snoise, snoise1, rcal2, rcal1, rcal0, & @@ -98,10 +102,12 @@ contains - subroutine rcal_double(xpht,xdpht,xcts,xdcts,ctph,dctph,verb,xreliable,xpoisson) + subroutine rcal_double(xpht,xdpht,xcts,xdcts,ctph,dctph,verb,xreliable, & + xpoisson) use rfun use weightedmean + use medians real(dbl), dimension(:), target, intent(in) :: xpht,xdpht,xcts,xdcts real(dbl), intent(in out) :: ctph,dctph @@ -109,8 +115,8 @@ logical, optional, intent(out) :: xreliable, xpoisson integer :: ndat,n,i,nplus,nstep - real(dbl) :: d,c,r,w,sig,tpht,tcts,dtpht,dtcts - logical :: reliable, poisson + real(dbl) :: d,c,r,w,sig,t0,s0,regold,sigold + logical :: reliable, poisson, convergent if( present(verb) ) verbose = verb @@ -134,13 +140,14 @@ ! data check if( .not. (all(xpht > 0) .and. all(xcts > 0) .and. all(xdpht > 0) .and. & all(xdcts > 0) ) ) & - stop 'robratio.f08: rcal has got invalid data (negative or zero counts).' + stop 'robratio.f08: rcal got invalid data (negative or zero counts).' if( size(cts) /= size(pht) ) stop 'robratio.f08: size(cts) /= size(pht)' if( size(dcts) /= size(dpht) ) stop 'robratio.f08: size(dcts) /= size(dpht)' if( size(cts) /= size(dcts) ) stop 'robratio.f08: size(cts) /= size(dcts)' if( size(pht) /= size(dpht) ) stop 'robratio.f08: size(pht) /= size(dpht)' - allocate(pht(ndat),cts(ndat),dpht(ndat),dcts(ndat),res(ndat),dpht2(ndat),dcts2(ndat)) + allocate(pht(ndat),cts(ndat),dpht(ndat),dcts(ndat),res(ndat),& + dpht2(ndat),dcts2(ndat)) pht = xpht cts = xcts dpht = xdpht @@ -151,32 +158,20 @@ dcts2 = dcts**2 ! determine range for ratio -! write(*,*) minval(cts),maxval(cts),minval(pht),maxval(pht) rmin = minval(pht/cts) rmax = maxval(pht/cts) -! call rwmean(pht,dpht,tpht,dtpht) -! write(*,*) tpht,dtpht -! call rwmean(cts,dcts,tcts,dtcts) -! write(*,*) tcts,dtcts -! ctph = tpht / tcts -! sig = ctph * (dtpht / tpht + dtcts / tcts) -! rmin = ctph - sig -! rmax = ctph + sig + ! no regularisation + reg = 0 i = max(int(log10(real(ndat))) - 1,0) nstep = 10**i -! if( ndat > 100 ) then -! nstep = ndat / 100 -! else -! nstep = 1 -! end if + if( verbose .and. nstep > 1 ) write(*,'(a,i0,a)') & + 'Warning: printing only every ',nstep,'th datapoint.' ! initial estimate of ctph and spread, by absolute values call rinit(ctph,sig) call residuals(ctph,res) -! call rmean_graph(rmin,1d6,1d0) -! stop if( verbose ) then write(*,*) 'Data table: pht(i),dpht(i),cts(i),dcts(i), ratio, residuals' @@ -216,7 +211,50 @@ case(2) ! Poisson (for low counts), Normal otherwise with var() ~= 1 - call rcal2(ctph,dctph,sig,reliable,poisson) + +! call rcal3(ctph,dctph,sig,reliable,poisson) + + t0 = ctph + s0 = sig + + sigold = -1 + do i = 0,666,10 + reg = i + call rcal2(ctph,sig,reliable,poisson) +! write(*,*) reg,ctph,sig + if( sig < 1 ) exit + sigold = sig + regold = reg + end do + ! solve reg. parameter by linear interpolation to the condition sig=1 + if( sigold > 0 .and. abs(sig - sigold) > epsilon(sig) ) then + reg = regold + (1 - sigold)*(reg - regold)/(sig - sigold) + call rcal2(ctph,sig,reliable,poisson) + end if + + if( verbose ) & + write(*,'(a50,1pg15.3)') 'Regularisation parameter:',reg + + if( reliable ) then + + t0 = ctph + s0 = sig + + call rnewton(ctph,dctph,sig,convergent) + + reliable = convergent .and. (rmin <= ctph .and. ctph <= rmax) + + if( verbose ) write(*,'(a50,1pg15.5,1x,0pg8.2,l3)') & + 'Robust mean by Newton with std.err.:',ctph,dctph,convergent + end if + + if( .not. reliable ) then + ctph = t0 + sig = s0 + dctph = sig * ctph * median(sqrt(ctph**2*dcts2 + dpht2)) / & + (0.6745 * median((cts*ctph + pht)/2)) +! dctph = median(sig*sqrt(t**2*dcts**2 + dpht**2)) / 0.6745 + end if case default ! No default is here, initial estimates will be used @@ -239,23 +277,25 @@ else r = 0 end if - write(*,'(i3,1p2g13.4,0p2f10.5,3f8.3)') i,pht(i),c,d,w,r,huber(r),dhuber(r) + write(*,'(i3,1p2g13.4,0p2f10.5,3f8.3)') & + i,pht(i),c,d,w,r,huber(r),dhuber(r) enddo n = count(abs(res) < sig) nplus = count(res > 0) write(*,'(a,g0.5,a,1pg0.1,a,5x,a,g0.3)') & 'ctph = ',ctph,' +- ',dctph,',','sig = ',sig - write(*,'(a,i0,a,i0,a,f0.1,a)') 'Points within 1-sigma error interval: ', & + write(*,'(a,i0,a,i0,a,f0.1,a)') & + 'Points within 1-sigma error interval: ', & n,'/',ndat,' (',100.*real(n)/real(ndat),'%)' - write(*,'(a,i0,"/",f0.1,", ",i0,"+-",f0.1)') 'Sign test (total/expected, +): ',& + write(*,'(a,i0,"/",f0.1,", ",i0,"+-",f0.1)') & + 'Sign test (total/expected, +): ',& ndat,ndat/2.0,nplus,sqrt(nplus*0.25) - ! test whatever the errors corresponds to values to prove Poisson origin + ! Test whatever the errors corresponds to values to prove + ! Poisson's origin. It is quantity like ! https://en.wikipedia.org/wiki/Index_of_dispersion - w = sum(dpht**2/pht)/ndat - d = sum(dcts**2/cts)/ndat - res = dpht**2/pht - write(*,'(a,2(1x,g0.3,1x,a,:","))') & - 'Index of dispersion (variance/mean): ',w,'(reference)',d,'(data)' + write(*,'(a,2(1x,g0.3,1x,a,:","))') 'Mean Poissonity (best=1): ',& + sqrt(sum(dpht**2/pht)/ndat),'(reference)', & + sqrt(sum(dcts**2/cts)/ndat),'(data)' end if deallocate(res,pht,cts,dpht,dcts,dpht2,dcts2) @@ -265,7 +305,8 @@ end subroutine rcal_double - subroutine rcal_single(xpht,xdpht,xcts,xdcts,ctph,dctph,xverb,xreliable,xpoisson) + subroutine rcal_single(xpht,xdpht,xcts,xdcts,ctph,dctph,xverb,xreliable,& + xpoisson) real, dimension(:), target, intent(in) :: xpht,xdpht,xcts,xdcts real, intent(in out) :: ctph,dctph @@ -283,10 +324,14 @@ verb = .false. end if - if( size(xcts) /= size(xpht) ) stop 'robratio.f08, single: size(cts) /= size(pht)' - if( size(xdcts) /= size(xdpht) ) stop 'robratio.f08, single: size(dcts) /= size(dpht)' - if( size(xcts) /= size(xdcts) ) stop 'robratio.f08, single: size(cts) /= size(dcts)' - if( size(xpht) /= size(xdpht) ) stop 'robratio.f08, single: size(pht) /= size(dpht)' + if( size(xcts) /= size(xpht) ) & + stop 'robratio.f08, single: size(cts) /= size(pht)' + if( size(xdcts) /= size(xdpht) ) & + stop 'robratio.f08, single: size(dcts) /= size(dpht)' + if( size(xcts) /= size(xdcts) ) & + stop 'robratio.f08, single: size(cts) /= size(dcts)' + if( size(xpht) /= size(xdpht) ) & + stop 'robratio.f08, single: size(pht) /= size(dpht)' n = size(xpht) allocate(pht(n),dpht(n),cts(n),dcts(n)) @@ -317,7 +362,12 @@ t2 = t**2 ! r = (pht - t*cts) / sqrt(t**2*dcts**2 + dpht**2) - r = (pht - t*cts) / sqrt(t2*dcts2 + dpht2) +! r = (pht - t*cts) / sqrt(t2*dcts2 + dpht2 + (pht+t*cts)/2* reg**2) + r = (pht - t*cts) / sqrt(t2*dcts2 + dpht2 + pht* reg**2) +! r = (pht - t*cts) / (dcts*sqrt(t) + dpht) + +! write(*,*) pht(1),cts(1),dcts2(1),dpht2(1),r(1),t,& +! (pht(1)-t*cts(1))/sqrt(t2*dcts2(1)+dpht2(1)),t2,r(1) end subroutine residuals @@ -329,26 +379,27 @@ t2 = t**2 ! r = (pht - t*cts) / sqrt(t**2*dcts**2 + dpht**2) - ds = sqrt(t2*dcts2 + dpht2) - r = (pht - t*cts) / ds +! ds = sqrt(t2*dcts2 + dpht2 + (pht+t*cts)/2* reg**2) + ds = sqrt(t2*dcts2 + dpht2 + pht* reg**2) + r = (pht - t*cts) / ds +! ds = dcts*sqrt(t) + dpht +! r = (pht - t*cts) / ds end subroutine residuals2 ! -------------------------------------------------------- - subroutine rcal2(ctph,dctph,sig,reliable,poisson) + subroutine rcal2(ctph,sig,reliable,poisson) use rfun - use medians real(dbl), intent(in out) :: ctph, sig - real(dbl), intent(out) :: dctph logical, intent(out) :: reliable,poisson integer :: n real(dbl) :: t,dt,s,s0,t0 - logical :: convergent, reli, treli, sreli + logical :: reli, treli, sreli n = size(pht) t = ctph @@ -359,7 +410,6 @@ call pmean(ctph) dt = sig - dctph = sig / sqrt(n - 1.0) reliable = .true. else @@ -376,43 +426,63 @@ if( verbose ) write(*,'(a50,1pg15.5,1x,0pg8.2,1x,2l1)') & 'Robust mean estimation, sig by entropy:',t,s,treli,sreli - if( reli ) then - - t0 = t - s0 = s - - call rnewton(t,dt,s,convergent) - -! reliable = convergent .and. abs(t-t0) < 10*dt - reliable = convergent .and. (rmin <= t .and. t <= rmax) - - if( verbose )write(*,'(a50,1pg15.5,1x,0pg8.2,l3)') & - 'Robust mean by Newton with std.err.:',t,dt,convergent - end if + reliable = reli .and. (rmin <= t .and. t <= rmax) if( reliable ) then ctph = t - dctph = dt sig = s else ctph = t0 sig = s0 - dctph = sig * ctph * qmedian(sqrt(ctph**2*dcts2 + dpht2)) / & - (0.6745 * qmedian((cts*ctph + pht)/2)) -! dctph = median(sig*sqrt(t**2*dcts**2 + dpht**2)) / 0.6745 end if end if if( debug ) then call snoise_graph(ctph,sig) - call rmean_graph(ctph-5*dctph,ctph+5*dctph,sig) + call rmean_graph(ctph-3*sig,ctph+5*sig,sig) call poisson_graph end if end subroutine rcal2 - +!!$ subroutine rcal3(ctph,dctph,sig,reliable,poisson) +!!$ +!!$ use rfun +!!$ use medians +!!$ use fmm +!!$ +!!$ real(dbl), intent(in out) :: ctph, sig +!!$ real(dbl), intent(out) :: dctph +!!$ logical, intent(out) :: reliable,poisson +!!$ real(dbl), parameter :: tol = 1e-2 +!!$ real(dbl), parameter :: regmin = 0 +!!$ real(dbl), parameter :: regmax = 1e3 +!!$ +!!$ sigma = sig +!!$ xctph = ctph +!!$! sig = fmin(regmin,regmax,sigfun,tol) +!!$ sig = zeroin(regmin,regmax,sigfun,tol) +!!$ +!!$ ctph = xctph +!!$ call rcal2(ctph,dctph,sig,reliable,poisson) +!!$ +!!$ end subroutine rcal3 +!!$ +!!$ function sigfun(r) +!!$ +!!$ real(dbl) :: sigfun +!!$ real(dbl), intent(in) :: r +!!$ real(dbl) :: ctph,dctph, s +!!$ logical :: reliable,poisson +!!$ +!!$ reg = r +!!$! s = sig +!!$ call rcal2(xctph,dctph,sigma,reliable,poisson) +!!$ xctph = ctph +!!$ sigfun = sigma - 1 +!!$ +!!$ end function sigfun subroutine rcal1(ctph,dctph,sig) @@ -448,7 +518,8 @@ end if if( .not. convergent .and. verbose ) & - write(*,*) "Warning: Likelihood and entropy iterations shows no convergence!" + write(*,*) & + "Warning: Likelihood and entropy iterations shows no convergence!" if( debug ) call snoise_graph(ctph,sig) @@ -466,14 +537,14 @@ integer :: n,iter real(dbl) :: xtol,d,f,df,f2 - real(dbl), dimension(:), allocatable :: r,psi,dpsi,ds,rs,ds2,cs,dd,d1s,d2s + real(dbl), dimension(:), allocatable :: r,psi,dpsi,ds,rs,ds2 convergent = .false. if( .not. (s > 0) ) return n = size(pht) - allocate(r(n),psi(n),dpsi(n),ds(n),rs(n),cs(n),ds2(n),dd(n),d1s(n),d2s(n)) + allocate(r(n),psi(n),dpsi(n),ds(n),rs(n),ds2(n)) ! tolerance limit will depends on number of elements in sums ! because every element can include its rounding error... @@ -483,39 +554,28 @@ do iter = 1, maxit ! solution of f(t) = 0, where f(t) = sum(psi((n-t*c)/(s*ds)) -! call residuals(t,r) call residuals2(t,r,ds) rs = r / s -! ds2 = t**2*dcts**2 + dpht**2 -! ds2 = t**2*dcts2 + dpht2 - ! ds = sqrt(ds2) ds2 = ds**2 -! call hubers(rs,psi) -! call dhubers(rs,dpsi) call tukeys(rs,psi) call dtukeys(rs,dpsi) - dd = pht - t*cts - d1s = t*dcts**2/ds - d2s = dcts**2*(ds - t*d1s)/ds2 - cs = cts*ds + dd*d1s - - f = - sum(psi*cs/s/ds2) + sum(d1s/ds) - df = sum(dpsi*(cs/s/ds2)**2) - & - sum(psi*(dd*(d2s*ds-2*d1s**2)-2*cts*ds*d1s)/s/ds**3) + & - sum((d2s*ds - d1s**2)/ds**2) - if( abs(df) < epsilon(df) ) exit + f = t*sum((psi*r-1.0_dbl)*(dcts/ds)**2) + sum(psi*cts/ds) + df = sum(dpsi*(cts/ds + r*t*dcts2/ds2)**2) & + -sum(psi*(pht - 3*t*cts)*(dcts/ds)**2/ds) & + +sum(psi*3*r*t**2*(dcts/ds)**4) & + +sum((dcts/ds)**2) - 2*t**2*sum((dcts2/ds2)**2) - ! where is s ??? + if( abs(df) < epsilon(df) ) exit ! corrector for mean - d = f / df + d = s * f / df ! update location - t = t - d + t = t + d - if( debug ) & - write(*,'(a,i2,1pg14.5,1p3g12.3)') "mean, incr., f, f': ",iter,t,d,f,df + if( debug ) write(*,'(a,i2,1pg20.10,1p3g12.3)') & + "mean, incr., f, f': ",iter,t,d,f,df convergent = abs(d) < xtol @@ -525,15 +585,13 @@ enddo f2 = sum(psi**2) ! mean of psi**2 - ! d = sum(dpsi) ! mean of dpsi df = df * s**2 ! write(*,*) f2,d,df if( convergent .and. df > 0 .and. f2 > 0 ) then -! dt = s*sqrt(f2/d**2*n/(n-1)/df) ! df is an element of Jacobian dt = s*sqrt(f2/df**2*n/(n-1)) ! df is an element of Jacobian end if - deallocate(r,psi,dpsi,ds,rs,cs,ds2,dd,d1s,d2s) + deallocate(r,psi,dpsi,ds,rs,ds2) end subroutine rnewton @@ -1036,20 +1094,44 @@ use fmm use medians + use qmeans real(dbl), intent(out) :: t,s integer :: n - real(dbl) :: rtol + real(dbl) :: d,ds +! real(dbl) :: rtol - rtol = 1e-5*max(1.0,rmax) +! rtol = 1e-5*max(1.0,rmax) ! t = fmin(rmin,rmax,ratiomin,rtol) - t = qmedian(pht/cts) + n = size(pht) - call residuals(t,res) - s = qmedian(abs(res)) / 0.6745 -! write(*,*) t,s + if( n > 30 ) then + t = qmedian(pht/cts) + ds = qmedian(sqrt(t**2*dcts2 + dpht2)) + s = qmedian(abs(pht - t*cts)) / (0.6745*ds) + else if( n > 13 ) then + t = median(pht/cts) + ds = median(sqrt(t**2*dcts2 + dpht2)) + s = median(abs(pht - t*cts)) / (0.6745*ds) + else if( n > 2 ) then + call qmean(pht/cts,t,d) + call qmean(sqrt(t**2*dcts2 + dpht2),ds,d) + call qmean(abs(pht - t*cts),s,d) + s = s / (0.6745*ds) + else if( n > 0 ) then + t = sum(pht/cts) / n + ds = sum(sqrt(t**2*dcts2 + dpht2)) / n + s = sum(abs(pht - t*cts)) / (n * ds) + else + t = 0 + s = 0 + end if + + + +! write(*,*) t,s,n ! allocate(ds(n)) ! call residuals2(t,res,ds) @@ -1094,30 +1176,27 @@ logical, intent(out) :: reli real(dbl) :: htol,d,tmin,tmax -! htol = max(1e-3*sum(dpht/pht + dcts/cts)/size(dpht),tol) - htol = 1e-7*max(1.0,rmax) - hsig = s - -! d = s * qmedian(sqrt(dpht**2 + t**2*dcts**2)) / 0.6745 - d = s !* qmedian(sqrt(dpht2 + t**2*dcts2)) / (0.6745 * qmedian((t*cts + pht)/2)) -! d = s * smed / 0.6745 - d = s / 0.6745 - htol = 0.001*d +! htol = 1e-7*max(1.0,rmax) + sigma = s - if( size(pht) > 23 ) then + d = 3.3 * qmedian(abs(pht/cts - t)) / 0.6745 + htol = 1e-5*d + + if( size(pht) > 13 ) then tmin = max(t - d,rmin) tmax = min(t + d,rmax) else tmin = rmin tmax = rmax end if -! write(*,*) tmin,tmax,d +! write(*,*) tmin,tmax,d,s,qmedian(sqrt(dpht**2 + t**2*dcts**2)) t = zeroin(tmin,tmax,zfun,htol) d = 2*htol - reli = abs(t - rmin) > d .and. abs(rmax - t) > d + reli = rmin + d < t .and. t < rmax - d - ! a result is too close to interval endpoints, it does raise suspicion ... + ! the realiable result is inside interval rmin .. rmax + ! and not too close to the interval endpoints end subroutine zmean @@ -1133,14 +1212,10 @@ n = size(pht) allocate(phi(n),ds(n)) -! ds = sqrt(dpht**2 + t**2*dcts**2) -! ds = sqrt(dpht2 + t**2*dcts2) call residuals2(t,res,ds) -! call hubers(res/hsig,phi) - call tukeys(res/hsig,phi) + call tukeys(res/sigma,phi) -! zfun = sum(phi*(cts*dpht**2 + pht*t*dcts**2)/ds**3)/hsig - t*sum(dcts**2/ds**2) - zfun = sum(phi*(cts*dpht2 + pht*t*dcts2)/ds**3)/hsig - t*sum(dcts2/ds**2) + zfun = (t*sum((phi*res - 1.0_dbl)*(dcts/ds)**2) + sum(phi*cts/ds))/sigma deallocate(phi,ds) @@ -1175,8 +1250,8 @@ allocate(f(size(pht))) - ! The density for Poisson distribution is computed by numerically - ! reliable way: https://en.wikipedia.org/wiki/Poisson_distribution#Definition + ! The density for Poisson distribution is computed by the way: + ! https://en.wikipedia.org/wiki/Poisson_distribution#Definition f = pht*log(t*cts) - t*cts - log_gamma(pht + 1) f = exp(f) @@ -1247,9 +1322,10 @@ t = t1 + dt*i call residuals(t,r) - call ihubers(r/s,rho) +! call ihubers(r/s,rho) + call itukeys(r/s,rho) - write(1,*) t,loglikely((/t,s/)),sum(rho) + write(1,*) t,loglikely((/t,s/)),sum(rho),zfun(t) end do close(1) diff -Nru munipack-0.5.9/lib/rwmean.f95 munipack-0.5.10/lib/rwmean.f95 --- munipack-0.5.9/lib/rwmean.f95 2017-07-17 23:03:48.000000000 +0000 +++ munipack-0.5.10/lib/rwmean.f95 2018-01-16 17:58:04.000000000 +0000 @@ -25,9 +25,9 @@ ! This module provides subroutines for estimation of both ! robust mean and its deviations. ! - ! rmean should be called as: + ! rwmean should be called as: ! - ! call rmean(x,dx,t,dt,sig,reliable) + ! call rwmean(x,dx,t,dt,sig,scale,reliable) ! ! on input: ! x - array of data values to be estimated @@ -35,8 +35,9 @@ ! ! on output are estimated: ! t - robust mean - ! dt - standard error + ! dt - standard error (optional) ! sig - standard deviation (optional) + ! scale - scale (optional) ! reliable - indicates reliability of results (optional) ! ! The given results means that a true value X of the sample x can be, @@ -51,7 +52,7 @@ ! WARNING ! ! This routine gives unexpected results when input errors in dx - ! are incorrectly determined. In this case, sig is significantly + ! are incorrectly determined. In this case, scale is significantly ! different from number one. The reliable flag is set to .false. ! ! @@ -77,6 +78,9 @@ ! private working arrays real(dbl), dimension(:), allocatable, private :: r,rs,psi,dpsi,z,dz + ! data limits + real(dbl), private :: xmin, xmax + ! implemened in both single and double precision interface rwmean module procedure rwmean2, rwmean1 @@ -87,37 +91,36 @@ contains - subroutine rwmean2(x,dx,t,dt,sig,reliable,verb) + subroutine rwmean2(x,dx,t,dt,sig,scale,reliable,verb) use rfun use entropyscale real(dbl), dimension(:),intent(in) :: x, dx - real(dbl), intent(out) :: t, dt - real(dbl), intent(out), optional :: sig + real(dbl), intent(out) :: t + real(dbl), intent(out), optional :: dt,sig, scale logical, intent(out), optional :: reliable logical, intent(in), optional :: verb real(dbl), parameter :: machtol = epsilon(t) - real(dbl) :: s,smed,s0,t0 + real(dbl) :: s,d,avar,s0,t0 integer :: n - logical :: converge, reli, treli, sreli, xverbose + logical :: converge, reli, treli, sreli - xverbose = verbose if( present(verb) ) verbose = verb if( size(x) /= size(dx) ) stop 'rwmean: size(x) /= size(dx)' if( .not. ( all(dx > 0) ) ) stop 'rwmean: any dx < 0' converge = .false. - dt = -1 + if( present(scale) ) scale = 1 n = size(x) if( n == 0 ) then t = 0 - dt = 0 + if( present(dt)) dt = 0 if( present(sig) ) sig = 1 if( present(reliable) ) reliable = .false. return @@ -125,43 +128,47 @@ else if( n == 1 ) then t = x(1) - dt = dx(1) + if( present(dt) ) dt = dx(1) if( present(sig) ) sig = 1 if( present(reliable) ) reliable = .false. return else if( n == 2 ) then - smed = (dx(1) + dx(2)) / 2 + avar = (dx(1) + dx(2)) / 2 t = (x(1) + x(2)) / 2 - s = abs(x(1) - x(2)) / smed - dt = s / 1.41 + s = abs(x(1) - x(2)) / avar + if( present(dt) ) dt = s / sqrt(2.0) if( present(sig) ) sig = s if( present(reliable) ) reliable = .true. return end if + xmin = minval(x) + xmax = maxval(x) + ! initial estimate - call rwinit(x,dx,t,s,smed) - if( verbose ) write(*,'(a,1p3g17.7)') 'rwinit:',t,s,smed + call rwinit(x,dx,t,s,avar) + if( verbose ) write(*,'(a,1p3g17.7)') 'rwinit:',t,s,avar if( abs(s) < 2*epsilon(s) )then ! The power of the robust method can be performed ! only on large dataset. - ! If all the data are identical, results can be considered as reliable. + ! If most of the data is identical, results can be considered + ! as reliable. reli = sum(abs(x-t)) / n < 10*epsilon(s) - dt = smed / sqrt(real(n)) + if( present(dt) ) dt = avar / sqrt(real(n)) if( present(reliable) ) reliable = reli if( present(sig) ) sig = s return endif - ! we are suppose that n > 2 from this point + ! we are suppose n > 2, below this point ! keep initial estimation t0 = t @@ -174,7 +181,7 @@ if( debug ) call zero_graph(x,dx,t,s) ! zmean is a solver without derivatives - call zmean(x,dx,smed,s,t,treli) + call zmean(x,dx,s,t,treli) ! The scale parameter estimates average dispersion of residuals ! scaled by theirs, a priory known, statistical errors (dx). @@ -182,7 +189,8 @@ call escale((x-t)/dx,s,sreli) reli = treli .and. sreli - if( verbose ) write(*,'(a,1p2g17.7,1x,2l1)') 'zmean, escale:',t,s,treli,sreli + if( verbose ) & + write(*,'(a,1p2g17.7,1x,2l1)') 'zmean, escale:',t,s,treli,sreli if( reli ) then @@ -192,10 +200,10 @@ ! Newton's iterations are used mainly to get more precise result and ! to estimate of std.err. - call newton(x,dx,s,t,dt,converge) - reli = converge .and. (minval(x) < t .and. t < maxval(x)) + call newton(x,dx,s,t,d,converge) + reli = converge .and. (xmin < t .and. t < xmax) - if( verbose ) write(*,'(a,1p3g17.7,2l3)') 'Newton:',t,dt,reli,converge + if( verbose ) write(*,'(a,1p3g17.7,2l3)') 'Newton:',t,d,reli,converge end if @@ -209,33 +217,35 @@ t = t0 s = s0 - if( dt < 0 ) dt = smed * sqrt(s**2/n) + d = avar * sqrt(s**2/n) - if( debug ) write(*,*) 'rmean5 (not reliable):',t,t0,s,s0,dt,converge + if( debug ) write(*,*) 'rmean5 (not reliable):',t,t0,s,s0,d,converge end if - if( verbose ) write(*,'(a,3g15.5,1x,l1)') 'rwmean2:',real(t),real(dt),real(s),reli + if( verbose ) & + write(*,'(a,3g15.5,1x,l1)') 'rwmean2:',real(t),real(d),real(s),reli deallocate(r,rs,psi,dpsi) ! fill-up optional items - if( present(sig) ) sig = s + if( present(dt) ) dt = d + if( present(sig) ) sig = s * avar + if( present(scale) ) scale = s if( present(reliable) ) reliable = reli - verbose = xverbose end subroutine rwmean2 - subroutine rwmean1(x,dx,t,dt,sig,reliable,verb) + subroutine rwmean1(x,dx,t,dt,sig,scale,reliable,verb) ! single precision version real, dimension(:),intent(in) :: x, dx - real, intent(out) :: t, dt - real, intent(out), optional :: sig + real, intent(out) :: t + real, intent(out), optional :: dt,sig,scale logical, intent(out), optional :: reliable logical, intent(in), optional :: verb - real(dbl) :: q,dq,sig2 + real(dbl) :: q,dq,sig2,s2 real(dbl), dimension(:), allocatable :: y,dy logical :: reliable2 @@ -245,11 +255,12 @@ y = x dy = dx - call rwmean2(y,dy,q,dq,sig2,reliable2) + call rwmean2(y,dy,q,dq,sig2,s2,reliable2) t = real(q) - dt = real(dq) + if( present(dt) ) dt = real(dq) if( present(sig) ) sig = real(sig2) + if( present(scale) ) scale = real(s2) if( present(reliable) ) reliable = reliable2 deallocate(y,dy) @@ -270,7 +281,8 @@ use rfun real(dbl), dimension(:), intent(in) :: x, dx - real(dbl), intent(in out) :: t,s + real(dbl), intent(in) :: s + real(dbl), intent(in out) :: t real(dbl), intent(out) :: dt logical, intent(out) :: converge @@ -304,8 +316,9 @@ ! derivative (denominator) checkpoint: ! * If all values are out of range: |df| < epsilon - ! * df < 0 indicates "re-descending M-estimate" function problem ... the problem - ! usually appears when distribution strongly deviates from Normal distribution + ! * df < 0 indicates "re-descending M-estimate" function problem ... + ! the problem usually appears when distribution strongly deviates + ! from Normal distribution if( df < epsilon(df) ) exit ! corrector for mean @@ -314,8 +327,8 @@ ! update location t = t + d - if( debug ) & - write(*,'(a,i2,g15.5,1p3g12.3)') "mean, incr., f, f': ",iter,t,d,-f/s,df/s**2 + if( debug ) write(*,'(a,i2,g15.5,1p3g12.3)') & + "mean, incr., f, f': ",iter,t,d,-f/s,df/s**2 ! exit of iterations: the absolute errot must be at least |d| < tol converge = abs(d) < tol @@ -327,34 +340,32 @@ if( converge ) then f2 = sum(psi**2/dx**2) if( f2 > 0 .and. df > 0 ) then - s = s*sqrt(n/(n-1)*f2/df) - dt = s/sqrt(df) +! s = s*sqrt(n/(n-1)*f2/df) + dt = s*sqrt(n/(n-1)*f2/df**2) end if end if end subroutine newton - subroutine zmean(x,dx,smed,s,t,reli) + subroutine zmean(x,dx,s,t,reli) use fmm + use medians real(dbl), dimension(:),intent(in) :: x, dx - real(dbl), intent(in) :: s,smed + real(dbl), intent(in) :: s real(dbl), intent(in out) :: t logical, intent(out) :: reli - real(dbl) :: tol,tmin,tmax,xmin,xmax,d + real(dbl) :: tol,tmin,tmax,d integer :: n n = size(x) - d = s * smed / q50 - tol = 0.001*d + d = 3.3 * qmedian(abs(x - t)) / q50 + tol = 1e-5*d allocate(z(n),dz(n)) - xmin = minval(x) - xmax = maxval(x) - - if( n > 23 ) then + if( n > 7 ) then tmin = max(t - d,xmin) tmax = min(t + d,xmax) else @@ -373,6 +384,8 @@ d = 2*tol reli = abs(t - tmin) > d .and. abs(tmax - t) > d +! if( .not. reli ) write(*,*) tmin,tmax,d,3.3*smed/q50,xmin,xmax,'|',x + ! if result is too close to interval endpoints, one raise suspicion ... end subroutine zmean diff -Nru munipack-0.5.9/list/Makefile.in munipack-0.5.10/list/Makefile.in --- munipack-0.5.9/list/Makefile.in 2017-07-17 23:04:25.000000000 +0000 +++ munipack-0.5.10/list/Makefile.in 2018-01-16 17:58:15.000000000 +0000 @@ -268,7 +268,6 @@ builddir = @builddir@ datadir = @datadir@ datarootdir = @datarootdir@ -develop = @develop@ docdir = @docdir@ dvidir = @dvidir@ exec_prefix = @exec_prefix@ diff -Nru munipack-0.5.9/list/mtable.f95 munipack-0.5.10/list/mtable.f95 --- munipack-0.5.9/list/mtable.f95 2017-07-17 23:03:48.000000000 +0000 +++ munipack-0.5.10/list/mtable.f95 2018-01-16 17:58:03.000000000 +0000 @@ -1,7 +1,7 @@ ! ! munilist ! -! Copyright © 2012-6 F.Hroch (hroch@physics.muni.cz) +! Copyright © 2012-7 F.Hroch (hroch@physics.muni.cz) ! ! This file is part of Munipack. ! @@ -9,12 +9,12 @@ ! it under the terms of the GNU General Public License as published by ! the Free Software Foundation, either version 3 of the License, or ! (at your option) any later version. -! +! ! Munipack is distributed in the hope that it will be useful, ! but WITHOUT ANY WARRANTY; without even the implied warranty of ! MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the ! GNU General Public License for more details. -! +! ! You should have received a copy of the GNU General Public License ! along with Munipack. If not, see . @@ -76,15 +76,13 @@ endif ! read date and time - call ftgkys(20,fitskeys(1),line,buf,status) - call fts2tm(line,y1,m1,d1,h1,min1,sec,status) - year = y1; month = m1; day = d1; hour = h1; min = min1 - - if( h1 == 0 .and. min1 == 0 ) then - call ftgkys(20,fitskeys(2),line,buf,status) - call fts2tm(line,y1,m1,d1,h1,min1,sec,status) - hour = h1; min = min1 - endif + call datetime(20,fitskeys(1:2),y1,m1,d1,h1,min1,sec,status) + if( status == 0 ) then + year = y1; month = m1; day = d1; hour = h1; min = min1 + else +! if( verbose ) write(error_unit,*) "Warning: Failed to get date or time." + goto 666 + end if ! read date, time, exposure, filter call ftgkyd(20,fitskeys(3),exptime,buf,status) @@ -167,7 +165,7 @@ ncols = size(coonames) allocate(coo(nrows,ncols)) allocate(tmp(nrows)) - + do i = 1, ncols call ftgcno(20,.true.,coonames(i),colnum,status) call ftgcvd(20,colnum,frow,felem,nrows,nullval,tmp,anyf,status) @@ -191,4 +189,3 @@ end subroutine table end module mtable - diff -Nru munipack-0.5.9/list/timeseries.f95 munipack-0.5.10/list/timeseries.f95 --- munipack-0.5.9/list/timeseries.f95 2017-07-17 23:03:48.000000000 +0000 +++ munipack-0.5.10/list/timeseries.f95 2018-01-16 17:58:04.000000000 +0000 @@ -9,12 +9,12 @@ ! it under the terms of the GNU General Public License as published by ! the Free Software Foundation, either version 3 of the License, or ! (at your option) any later version. -! +! ! Munipack is distributed in the hope that it will be useful, ! but WITHOUT ANY WARRANTY; without even the implied warranty of ! MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the ! GNU General Public License for more details. -! +! ! You should have received a copy of the GNU General Public License ! along with Munipack. If not, see . @@ -25,7 +25,7 @@ use fitsio implicit none - + integer, parameter :: dbl = selected_real_kind(15) character(len=FLEN_FILENAME) :: filename,output,backup,cat character(len=4*FLEN_FILENAME) :: line,key,val, timetype = 'JD', timestamp = 'MID', & @@ -74,7 +74,7 @@ val = line(eq+1:) if( key == 'OUTPUT' ) then - + read(val,*) output,backup else if( key == 'VERBOSE' ) then @@ -108,23 +108,23 @@ else if( key == 'COOTYPE' ) then - + read(val,*) cootype else if( key == 'TIMETYPE' ) then - + read(val,*) timetype else if( key == 'TIMESTAMP' ) then - + read(val,*) timestamp else if( key == 'TIMEERR' ) then - + read(val,*) timeerr else if( key == 'TIMERES' ) then - + read(val,*) timeres else if( key == 'NCOO' ) then @@ -213,7 +213,7 @@ if( (size(cols) == 0 .or. size(coocols) == 0) .and. extname == PHOTOEXTNAME ) & call colinit(files(1)) - + call tmseries_init(timetype,timestamp,timeerr,timeres,cootype,nfiles,fitskeys, & extname,coocols,cols, tol,min0,per,epoch,diffmag, & verbose,stdout,ncoo==0) @@ -236,7 +236,7 @@ contains subroutine readcat(cat,epoch,ra,dec,pmra,pmdec,status) - + use fitsio character(len=*), intent(in) :: cat @@ -268,7 +268,7 @@ status = 0 epoch = 2451545.0_dbl end if - + call ftgncl(15,ncols,status) call ftgnrw(15,nrows,status) if( ncols /= size(labels) ) stop 'ncols /= size(labels)' @@ -284,7 +284,7 @@ call ftgkys(15,'TUNIT4',dunits,buf,status) allocate(ra(nrows),dec(nrows),pmra(nrows),pmdec(nrows)) - + call ftgcvd(15,col(1),frow,felem,nrows,nullval,ra,anyf,status) call ftgcvd(15,col(2),frow,felem,nrows,nullval,dec,anyf,status) call ftgcvd(15,col(3),frow,felem,nrows,nullval,pmra,anyf,status) @@ -293,7 +293,7 @@ if( status /= 0 ) goto 666 if( runits == 'arcsec/year' ) pmra = pmra / xpm - if( dunits == 'arcsec/year' ) pmdec = pmdec / xpm + if( dunits == 'arcsec/year' ) pmdec = pmdec / xpm call ftclos(15,status) if( status /= 0 ) goto 666 diff -Nru munipack-0.5.9/list/tmseries.f95 munipack-0.5.10/list/tmseries.f95 --- munipack-0.5.9/list/tmseries.f95 2017-07-17 23:03:48.000000000 +0000 +++ munipack-0.5.10/list/tmseries.f95 2018-01-16 17:58:03.000000000 +0000 @@ -228,9 +228,9 @@ if( verbose ) write(error_unit,*) trim(filename),":" - call table(filename, extname, gfitskeys, headkeys, coocols, cols, verbose,cootype,& - gfitsval,headval,photsys,filter,year,month,day,hour,min,sec,amass,exptime, & - t,coo,data,status) + call table(filename, extname, gfitskeys, headkeys, coocols, cols, & + verbose,cootype,gfitsval,headval,photsys,filter,year,month,day,& + hour,min,sec,amass,exptime,t,coo,data,status) if( status /= 0 ) then write(error_unit,*) "Failed to read `",trim(filename),"'." @@ -442,7 +442,7 @@ if( index(cols(i),'MAG') > 0 ) then fmt = trim(fmt) // 'f0.5' else - fmt = trim(fmt) // 'g0.5' + fmt = trim(fmt) // 'g0' end if if( i < n ) then fmt = trim(fmt) // ',1x,' diff -Nru munipack-0.5.9/Makefile.in munipack-0.5.10/Makefile.in --- munipack-0.5.9/Makefile.in 2017-07-17 23:04:25.000000000 +0000 +++ munipack-0.5.10/Makefile.in 2018-01-16 17:58:14.000000000 +0000 @@ -362,7 +362,6 @@ builddir = @builddir@ datadir = @datadir@ datarootdir = @datarootdir@ -develop = @develop@ docdir = @docdir@ dvidir = @dvidir@ exec_prefix = @exec_prefix@ diff -Nru munipack-0.5.9/minpack/Makefile.in munipack-0.5.10/minpack/Makefile.in --- munipack-0.5.9/minpack/Makefile.in 2017-07-17 23:04:25.000000000 +0000 +++ munipack-0.5.10/minpack/Makefile.in 2018-01-16 17:58:15.000000000 +0000 @@ -285,7 +285,6 @@ builddir = @builddir@ datadir = @datadir@ datarootdir = @datarootdir@ -develop = @develop@ docdir = @docdir@ dvidir = @dvidir@ exec_prefix = @exec_prefix@ diff -Nru munipack-0.5.9/munipack/artificial.cpp munipack-0.5.10/munipack/artificial.cpp --- munipack-0.5.9/munipack/artificial.cpp 2017-07-17 23:03:48.000000000 +0000 +++ munipack-0.5.10/munipack/artificial.cpp 2018-01-16 17:58:03.000000000 +0000 @@ -93,17 +93,14 @@ if( cmd.Found("lc-ra",&x) && cmd.Found("lc-dec",&y) ) action->Write("LCCOO = %20.15f %20.15f",x,y); - if( cmd.Found("back-level",&x) ) - action->Write("BLEVEL = %lf",x); + if( cmd.Found("sky-mag",&x) ) + action->Write("SKYMAG = %lf",x); - if( cmd.Found("back-noise",&x) ) - action->Write("BNOISE = %lf",x); + if( cmd.Found("sky-grad-x",&x) ) + action->Write("SKYGRADX = %lf",x); - if( cmd.Found("back-grad-x",&x) ) - action->Write("BGRADX = %lf",x); - - if( cmd.Found("back-grad-y",&x) ) - action->Write("BGRADY = %lf",x); + if( cmd.Found("sky-grad-y",&x) ) + action->Write("SKYGRADY = %lf",x); if( cmd.Found("area",&x) ) action->Write("AREA = %lf",x); diff -Nru munipack-0.5.9/munipack/astrometry.cpp munipack-0.5.10/munipack/astrometry.cpp --- munipack-0.5.9/munipack/astrometry.cpp 2017-07-17 23:03:48.000000000 +0000 +++ munipack-0.5.10/munipack/astrometry.cpp 2018-01-16 17:58:04.000000000 +0000 @@ -2,7 +2,7 @@ Astrometry - Copyright © 2010 - 2016 F.Hroch (hroch@physics.muni.cz) + Copyright © 2010 - 2017 F.Hroch (hroch@physics.muni.cz) This file is part of Munipack. @@ -119,12 +119,18 @@ if( cmd.Found("maxmatch",&i) ) action->Write("MAXMATCH = %ld",i); + if( cmd.Found("luckymatch",&i) ) + action->Write("LUCKYMATCH = %ld",i); + + if( cmd.Found("disable-lucky-match") ) + action->Write("LUCKYMATCH = 0"); + + if( cmd.Found("enable-full-match") ) + action->Write("FULLMATCH = T"); + if( cmd.Found("disable-flux-check") ) action->Write("FLUXCHECK = F"); - if( cmd.Found("disable-full-match") ) - action->Write("FULLMATCH = F"); - if( cmd.Found("disable-rms-check") ) action->Write("RMSCHECK = F"); diff -Nru munipack-0.5.9/munipack/cmd.cpp munipack-0.5.10/munipack/cmd.cpp --- munipack-0.5.9/munipack/cmd.cpp 2017-07-17 23:03:48.000000000 +0000 +++ munipack-0.5.10/munipack/cmd.cpp 2018-01-16 17:58:03.000000000 +0000 @@ -49,11 +49,11 @@ AddOption("B","bitpix","bitpix (-32,32,16,8)",wxCMD_LINE_VAL_NUMBER); #define COMMON_OPTIONS_PHTOLLS \ - AddOption("","tol-temp",L"limit for nearby temperatures (1°C)",wxCMD_LINE_VAL_DOUBLE); \ + AddOption("","tol-temp",L"limit for nearby temperatures (1°C)",wxCMD_LINE_VAL_DOUBLE);\ AddOption("","tol-exp",L"limit for nearby exposure times (1μsec)",wxCMD_LINE_VAL_DOUBLE); #define COMMON_OPTIONS_ARITH \ - AddSwitch("a",wxEmptyString,"arithmetical instead of robust mean"); + AddSwitch(wxEmptyString,"arith","arithmetical mean instead of robust mean"); #define COMMON_OPTIONS_ADDKEY \ AddOption("K","keys","key=value[,key=,..] add keyword(s) to header",wxCMD_LINE_VAL_STRING,wxCMD_LINE_PARAM_MULTIPLE); @@ -91,13 +91,13 @@ " calibrate\tcalibrate\n" */ "\nActions:\n" - " phcorr\t\tApply photometric precorrections\n" + " phcorr\t\tApply photometric corrections\n" " bias\t\tAveraged bias frame\n" " dark\t\tAveraged dark frame\n" " flat\t\tAveraged flat-field frame\n" - " coloring\tCompose color frame\n" + " coloring\tCompose colour frame\n" " kombine\tCompose frames (deep exposures, mosaics)\n" - " ctrafo\t\tTransform color frames between color-spaces\n" + " ctrafo\t\tTransform colour frames between colour-spaces\n" " cone\t\tCone search in a catalogue on Virtual Observatory\n" " astrometry\tAstrometry calibration\n" " find\t\tSearch for stars on frames\n" @@ -105,7 +105,7 @@ " gphot\t\tGrowth-Curve photometry\n" " phcal\t\tPhotometry calibration\n" " artificial\tArtificial frames\n" - " phfotran\tDetermine photometry system color transformation\n" + " phfotran\tDetermine photometry system transformation\n" " timeseries\tList arbitrary quantity to time-series\n" "\nLow Level Actions:\n" " votable\tConversions of VOTables\n" @@ -140,8 +140,8 @@ AddUsageText("Usage: munipack "+action+" [options] file(s)"); AddUsageText("* Averaged dark frame."); - COMMON_OPTIONS_ARITH AddOption("bias",wxEmptyString,"bias frame"); + COMMON_OPTIONS_ARITH COMMON_OPTIONS_PHTOLLS COMMON_OPTIONS_BITPIX COMMON_OPTIONS_SINGLE @@ -153,13 +153,17 @@ AddUsageText("Usage: munipack "+action+" [options] file(s)"); AddUsageText("* Averaged flat-field frame."); + AddOption("gain","","provide value of gain (rather than FITS keyword)", + wxCMD_LINE_VAL_DOUBLE); AddOption("bias",wxEmptyString,"bias frame"); AddOption("dark",wxEmptyString,"dark frame"); - AddOption("xdark",wxEmptyString,"dark frame multiplicator factor",wxCMD_LINE_VAL_DOUBLE); - AddOption("gain","","provide value of gain (rather than FITS keyword)",wxCMD_LINE_VAL_DOUBLE); - AddSwitch("","gain-estimate","estimate gain"); - AddOption(wxEmptyString,"level","output mean level (default 1.0)",wxCMD_LINE_VAL_DOUBLE); - AddOption(wxEmptyString,"saturate","saturation in ADU",wxCMD_LINE_VAL_DOUBLE); + AddOption("xdark",wxEmptyString,"dark frame exposure time factor", + wxCMD_LINE_VAL_DOUBLE); + AddOption("bitmask",wxEmptyString,"mask frame"); + AddOption("st","saturate","saturation in counts",wxCMD_LINE_VAL_DOUBLE); + AddOption("th","threshold","threshold in counts",wxCMD_LINE_VAL_DOUBLE); + AddSwitch("","gain-estimate","rough estimate of gain"); + AddOption("","approximation","precision: basic, standard (default)"); COMMON_OPTIONS_BITPIX COMMON_OPTIONS_SINGLE AddParam("file(s)",wxCMD_LINE_VAL_STRING,wxCMD_LINE_PARAM_MULTIPLE); @@ -168,17 +172,19 @@ else if( action == "phcorr" ) { AddUsageText("Usage: munipack "+action+" [options] file(s)[,result(s)]"); - AddUsageText("* Apply photometric precorrections (gain, bias, dark, flat-field)."); + AddUsageText("* Apply photometric corrections (gain, bias, dark, flat-field)."); + AddOption("gain","","provide value of gain (rather than FITS keyword)", + wxCMD_LINE_VAL_DOUBLE); AddOption("flat",wxEmptyString,"flat-field frame"); AddOption("bias",wxEmptyString,"bias frame"); AddOption("dark",wxEmptyString,"dark frame"); - AddOption("xdark",wxEmptyString,"dark frame multiplicator factor",wxCMD_LINE_VAL_DOUBLE); + AddOption("xdark",wxEmptyString,"dark frame exposure time factor", + wxCMD_LINE_VAL_DOUBLE); AddOption("bitmask",wxEmptyString,"mask frame"); AddOption("xbitmask",wxEmptyString,"mask frame as ZERO (default), MEAN (average)"); - AddOption("gain","","provide value of gain (rather than FITS keyword)",wxCMD_LINE_VAL_DOUBLE); AddSwitch("","gain-ignore","ignore gain transformation"); - AddSwitch(wxEmptyString,"normalise","Normalise on averaged flat-field level"); + AddSwitch(wxEmptyString,"normalise","normalise flat-field prior to use"); AddSwitch(wxEmptyString,"force","apply to already corrected frames"); COMMON_OPTIONS_PHTOLLS COMMON_OPTIONS_BITPIX @@ -189,10 +195,10 @@ else if( action == "coloring" ) { AddUsageText("Usage: munipack "+action+" [options] file(s)[,ext(s)]"); - AddUsageText("* Compose color frame."); + AddUsageText("* Compose colour frame."); AddOption("c",wxEmptyString,"colorspace"); - AddOption("ct",wxEmptyString,"color table"); + AddOption("ct",wxEmptyString,"colour table"); COMMON_OPTIONS_BITPIX COMMON_OPTIONS_SINGLE AddParam("files[,exts]",wxCMD_LINE_VAL_STRING, @@ -202,11 +208,11 @@ else if( action == "ctrafo" ) { AddUsageText("Usage: munipack "+action+" [options] file black(s),weight(s)"); - AddUsageText("* Transform color frames between various color-spaces."); + AddUsageText("* Transform colour frames between various colour-spaces."); - AddSwitch(wxEmptyString,"list","known colospaces"); - AddOption("c",wxEmptyString,"colorspace"); - AddOption("ct",wxEmptyString,"color table"); + AddSwitch(wxEmptyString,"list","known collapses"); + AddOption("c",wxEmptyString,"collapse"); + AddOption("ct",wxEmptyString,"colour table"); COMMON_OPTIONS_BITPIX COMMON_OPTIONS_SINGLE AddParam("file black,weight",wxCMD_LINE_VAL_STRING, @@ -219,7 +225,8 @@ AddUsageText("* Cone search in catalogues of Virtual Observatory."); AddOption("c","cat","catalogue (see --list-catalogues)"); - AddOption("r","radius","radius for cone search [deg] (default 0.1)",wxCMD_LINE_VAL_DOUBLE); + AddOption("r","radius","radius for cone search [deg] (default: 6 arcmin = 0.1)", + wxCMD_LINE_VAL_DOUBLE); AddOption("s","sort","sort by the column"); AddOption("","par","add optional parameters"); AddOption("","url","service URL"); @@ -242,9 +249,11 @@ AddOption("","type","type of output file: fits,csv,txt,svg,xml"); AddOption("s","","sort by the column"); AddOption("pt","","select projection: gnomon"); - AddOption("pa","","Right Ascension of projection center",wxCMD_LINE_VAL_DOUBLE); - AddOption("pd","","Declination of projection center",wxCMD_LINE_VAL_DOUBLE); + AddOption("pa","","Right Ascension of projection centre",wxCMD_LINE_VAL_DOUBLE); + AddOption("pd","","Declination of projection centre",wxCMD_LINE_VAL_DOUBLE); AddOption("ps","","scale of projection",wxCMD_LINE_VAL_DOUBLE); + AddOption("pw","","canvas width",wxCMD_LINE_VAL_NUMBER); + AddOption("ph","","canvas height",wxCMD_LINE_VAL_NUMBER); AddOption("ml","","magnitude limit",wxCMD_LINE_VAL_DOUBLE); AddOption("","col-ra","Right Ascension column"); AddOption("","col-dec","Declination column"); @@ -265,28 +274,46 @@ AddOption("p","projection","projection type: none, gnomonic (default)"); AddOption(wxEmptyString,"col-ra","Right Ascension column"); AddOption(wxEmptyString,"col-dec","Declination column"); - AddOption(wxEmptyString,"col-pm-ra","Proper motion in Right Ascension column"); + AddOption(wxEmptyString,"col-pm-ra", + "Proper motion in Right Ascension column"); AddOption(wxEmptyString,"col-pm-dec","Proper motion in Declination column"); AddOption(wxEmptyString,"col-mag","Magnitude-like column"); - AddOption(wxEmptyString,"xcen","center of frame [pix] (default: width/2)",wxCMD_LINE_VAL_DOUBLE); - AddOption(wxEmptyString,"ycen","center of frame [pix] (default: height/2)",wxCMD_LINE_VAL_DOUBLE); - AddOption(wxEmptyString,"rcen","center of FOV in Right Ascension [deg]",wxCMD_LINE_VAL_DOUBLE); - AddOption(wxEmptyString,"dcen","center of FOV in Declination [deg]",wxCMD_LINE_VAL_DOUBLE); + AddOption(wxEmptyString,"xcen","centre of frame [pix] (default: width/2)", + wxCMD_LINE_VAL_DOUBLE); + AddOption(wxEmptyString,"ycen","centre of frame [pix] (default: height/2)", + wxCMD_LINE_VAL_DOUBLE); + AddOption(wxEmptyString,"rcen","centre of FOV in Right Ascension [deg]", + wxCMD_LINE_VAL_DOUBLE); + AddOption(wxEmptyString,"dcen","center of FOV in Declination [deg]", + wxCMD_LINE_VAL_DOUBLE); AddOption(wxEmptyString,"scale","scale [deg/pix]",wxCMD_LINE_VAL_DOUBLE); - AddOption(wxEmptyString,"angle","rotation angle [deg], clockwise positive",wxCMD_LINE_VAL_DOUBLE); + AddOption(wxEmptyString,"angle","rotation angle [deg], clockwise positive", + wxCMD_LINE_VAL_DOUBLE); AddSwitch(wxEmptyString,"reflex","set reflection"); AddOption(wxEmptyString,"fit","robust (default) or squares"); - AddOption(wxEmptyString,"units","output units: deg,arcmin,arcsec,mas,uas,pix"); - AddOption(wxEmptyString,"rms","random errors in positions [deg]",wxCMD_LINE_VAL_DOUBLE); - AddOption(wxEmptyString,"sig","errors of centroids on frame [pix]",wxCMD_LINE_VAL_DOUBLE); - AddOption(wxEmptyString,"sigcat","coordinate errors of cat/ref [deg]",wxCMD_LINE_VAL_DOUBLE); - AddOption(wxEmptyString,"fsig","error in fluxes, default=1",wxCMD_LINE_VAL_DOUBLE); - AddOption(wxEmptyString,"minmatch","minimal length of match sequence",wxCMD_LINE_VAL_NUMBER); - AddOption(wxEmptyString,"maxmatch","maximum length of match sequence",wxCMD_LINE_VAL_NUMBER); + AddOption(wxEmptyString,"units", + "output units: deg,arcmin,arcsec,mas,uas,pix"); + AddOption(wxEmptyString,"rms","random errors in positions [deg]", + wxCMD_LINE_VAL_DOUBLE); + AddOption(wxEmptyString,"sig","errors of centroids on frame [pix]", + wxCMD_LINE_VAL_DOUBLE); + AddOption(wxEmptyString,"sigcat","coordinate errors of cat/ref [deg]", + wxCMD_LINE_VAL_DOUBLE); + AddOption(wxEmptyString,"fsig","error in fluxes, default=1", + wxCMD_LINE_VAL_DOUBLE); + AddOption(wxEmptyString,"minmatch","minimal length of match sequence", + wxCMD_LINE_VAL_NUMBER); + AddOption(wxEmptyString,"maxmatch","maximum length of match sequence", + wxCMD_LINE_VAL_NUMBER); + AddOption(wxEmptyString,"luckymatch","minimal reliable sequence, default=3", + wxCMD_LINE_VAL_NUMBER); AddOption("","seq1","sequence for reference"); AddOption("","seq2","sequence for calibrated"); - AddSwitch(wxEmptyString,"disable-full-match","disable full match"); - AddSwitch(wxEmptyString,"disable-flux-check","fluxes are not used during matching"); + AddSwitch(wxEmptyString,"disable-lucky-match", + "finish at first success match"); + AddSwitch(wxEmptyString,"enable-full-match","enable full match"); + AddSwitch(wxEmptyString,"disable-flux-check", + "fluxes are not used during matching"); AddSwitch(wxEmptyString,"disable-rms-check","disable RMS check"); AddSwitch(wxEmptyString,"disable-save","don't save calibration to header"); AddSwitch(wxEmptyString,"remove","remove complete astrometry calibration"); @@ -351,7 +378,7 @@ AddOption("c","column","column name(s) to list"); AddOption("C","coocolumn","column name(s) of coordinates (object search)"); - AddOption("x","extname","FITS extension identificator"); + AddOption("x","extname","FITS extension identification"); AddOption("T","time-type","JD (default), MJD, HJD, PHASE"); AddOption(wxEmptyString,"time-stamp","MID (default), BEGIN, END"); AddOption(wxEmptyString,"time-err","uncertainty in the time measurement [s]",wxCMD_LINE_VAL_DOUBLE); @@ -450,17 +477,27 @@ AddUsageText("* Compose frames (deep exposures, mosaics)."); AddOption("p","projection","projection: identity, gnomonic"); - AddOption(wxEmptyString,"xcen","center of frame [pix] (default: width/2)",wxCMD_LINE_VAL_DOUBLE); - AddOption(wxEmptyString,"ycen","center of frame [pix] (default: height/2)",wxCMD_LINE_VAL_DOUBLE); - AddOption(wxEmptyString,"rcen","center of FOV in Right Ascension [deg]",wxCMD_LINE_VAL_DOUBLE); - AddOption(wxEmptyString,"dcen","center of FOV in Declination [deg]",wxCMD_LINE_VAL_DOUBLE); - AddOption(wxEmptyString,"width","width of output [pix]",wxCMD_LINE_VAL_NUMBER); - AddOption(wxEmptyString,"height","height of output [pix]",wxCMD_LINE_VAL_NUMBER); - AddOption(wxEmptyString,"scale","scale [pix/deg]",wxCMD_LINE_VAL_DOUBLE); - AddOption(wxEmptyString,"angle","position angle [deg]",wxCMD_LINE_VAL_DOUBLE); + AddOption(wxEmptyString,"xcen","centre of frame [pix] (default: width/2)", + wxCMD_LINE_VAL_DOUBLE); + AddOption(wxEmptyString,"ycen","centre of frame [pix] (default: height/2)", + wxCMD_LINE_VAL_DOUBLE); + AddOption(wxEmptyString,"rcen","centre of FOV in Right Ascension [deg]", + wxCMD_LINE_VAL_DOUBLE); + AddOption(wxEmptyString,"dcen","centre of FOV in Declination [deg]", + wxCMD_LINE_VAL_DOUBLE); + AddOption(wxEmptyString,"width","width of output [pix]", + wxCMD_LINE_VAL_NUMBER); + AddOption(wxEmptyString,"height","height of output [pix]", + wxCMD_LINE_VAL_NUMBER); + AddOption(wxEmptyString,"scale","scale [pix/deg]", + wxCMD_LINE_VAL_DOUBLE); + AddOption(wxEmptyString,"angle","position angle [deg]", + wxCMD_LINE_VAL_DOUBLE); + AddOption("","reflex","[yes|no] set/unset reflection"); AddOption("i","interpol","interpolation: none,bilinear,bicubic"); //,bspline AddSwitch("","adjust","adjust sky level"); AddSwitch("","expomask","use exposure mask"); + AddSwitch("","average","compute average instead of summation"); COMMON_OPTIONS_BITPIX COMMON_OPTIONS_SINGLE AddParam("file(s)",wxCMD_LINE_VAL_STRING,wxCMD_LINE_PARAM_MULTIPLE); @@ -475,6 +512,9 @@ AddOption("c","cat","reference photometry catalogue"); AddOption("r","ref","reference frame"); AddOption("f","filters","list of filters"); + AddOption("th","threshold","select stars with the threshold above sky",wxCMD_LINE_VAL_DOUBLE); + AddOption("e","maxerr","select stars with the maximal relative error",wxCMD_LINE_VAL_DOUBLE); + AddOption("","apcorr","aperture correction",wxCMD_LINE_VAL_DOUBLE); AddOption(wxEmptyString,"col-ra","Right Ascension column"); AddOption(wxEmptyString,"col-dec","Declination column"); AddOption(wxEmptyString,"col-mag","magnitude column(s)"); @@ -497,7 +537,7 @@ else if( action == "phfotran" ) { AddUsageText("Usage: munipack "+action+" [options] file(s)"); - AddUsageText("* Determine photometry system color transformation."); + AddUsageText("* Determine photometry system colour transformation."); AddOption("c","cat","reference photometry catalogue"); AddOption("f","filters","list of filters"); @@ -525,44 +565,59 @@ AddOption("","psf","PSF function: SEEING, MOFFAT, GAUSS"); AddOption("","spread","seeing spread method: FFT, RANDOM, AUTO"); - AddOption("","hwhm","half width at half of maximum [pix]",wxCMD_LINE_VAL_DOUBLE); + AddOption("","hwhm","half width at half of maximum [pix]", + wxCMD_LINE_VAL_DOUBLE); AddOption("","airy","radius of Airy spot [pix]",wxCMD_LINE_VAL_DOUBLE); AddOption("","beta","Moffat exponent",wxCMD_LINE_VAL_DOUBLE); AddOption("","maglim","magnitude limit",wxCMD_LINE_VAL_NUMBER); AddOption("","lc-model","light curve model: Cepheid,Algol,wave(default)"); AddOption("","lc-table","light curve model in the table"); AddOption("","lc-fourier","light curve model by Fourier coefficients"); - AddOption("","lc-mag","mean magnitude of the variable object",wxCMD_LINE_VAL_DOUBLE); + AddOption("","lc-mag","mean magnitude of the variable object", + wxCMD_LINE_VAL_DOUBLE); AddOption("","lc-amp","amplitude of the curve",wxCMD_LINE_VAL_DOUBLE); - AddOption("","lc-jd0","reference Julian date for the light curve",wxCMD_LINE_VAL_DOUBLE); - AddOption("","lc-per","period for the light curve [days]",wxCMD_LINE_VAL_DOUBLE); - AddOption("","lc-ra","variable object Right Ascension [deg]",wxCMD_LINE_VAL_DOUBLE); - AddOption("","lc-dec","variable object Declination [deg]",wxCMD_LINE_VAL_DOUBLE); - AddOption("","back-level","background level [cts]",wxCMD_LINE_VAL_DOUBLE); - AddOption("","back-noise","background noise [cts]",wxCMD_LINE_VAL_DOUBLE); - AddOption("","back-grad-x","background gradient in x [cts/pix]",wxCMD_LINE_VAL_DOUBLE); - AddOption("","back-grad-y","background gradient in y [cts/pix]",wxCMD_LINE_VAL_DOUBLE); + AddOption("","lc-jd0","reference Julian date for the light curve", + wxCMD_LINE_VAL_DOUBLE); + AddOption("","lc-per","period for the light curve [days]", + wxCMD_LINE_VAL_DOUBLE); + AddOption("","lc-ra","variable object Right Ascension [deg]", + wxCMD_LINE_VAL_DOUBLE); + AddOption("","lc-dec","variable object Declination [deg]", + wxCMD_LINE_VAL_DOUBLE); + AddOption("","sky-mag","sky brightness [mag/arcsec2]", + wxCMD_LINE_VAL_DOUBLE); + AddOption("","sky-grad-x","sky change in x direction [mag/arcsec2/pix]", + wxCMD_LINE_VAL_DOUBLE); + AddOption("","sky-grad-y","sky change in y direction [mag/arcsec2/pix]", + wxCMD_LINE_VAL_DOUBLE); AddOption("","area","area of input aperture [m2]",wxCMD_LINE_VAL_DOUBLE); - AddOption("","diameter","diameter of input aperture [m]",wxCMD_LINE_VAL_DOUBLE); + AddOption("","diameter","diameter of input aperture [m]", + wxCMD_LINE_VAL_DOUBLE); AddOption("","exptime","exposure time [s]",wxCMD_LINE_VAL_DOUBLE); AddOption("","qeff","quantum efficiency",wxCMD_LINE_VAL_DOUBLE); - AddSwitch("","atmosphere","apply atmosphere modelling: extinction, seeing"); + AddSwitch("","atmosphere","apply atmosphere modelling: extinction+seeing"); AddOption("","extk","extinction coefficient",wxCMD_LINE_VAL_DOUBLE); - AddOption("","long","geographic longitude of station (-east)[deg]",wxCMD_LINE_VAL_DOUBLE); - AddOption("","lat","geographic latitude of station (+north)[deg]",wxCMD_LINE_VAL_DOUBLE); + AddOption("","long","geographic longitude of station (-east)[deg]", + wxCMD_LINE_VAL_DOUBLE); + AddOption("","lat","geographic latitude of station (+north)[deg]", + wxCMD_LINE_VAL_DOUBLE); AddOption("","date","initial date as YYYY-MM-DD"); AddOption("","time","initial time as HH:MM:SS"); - AddOption("","count","total number of generated files",wxCMD_LINE_VAL_NUMBER); + AddOption("","count","total number of generated files", + wxCMD_LINE_VAL_NUMBER); AddOption("","timestep","timestep in seconds",wxCMD_LINE_VAL_DOUBLE); AddOption("f","filter","photometry filter"); AddOption("c","cat","reference photometry catalogue"); AddOption("","fov","field of view [deg]",wxCMD_LINE_VAL_DOUBLE); - AddOption(wxEmptyString,"rcen","center of FOV in Right Ascension [deg]",wxCMD_LINE_VAL_DOUBLE); - AddOption(wxEmptyString,"dcen","center of FOV in Declination [deg]",wxCMD_LINE_VAL_DOUBLE); + AddOption(wxEmptyString,"rcen","centre of FOV in Right Ascension [deg]", + wxCMD_LINE_VAL_DOUBLE); + AddOption(wxEmptyString,"dcen","centre of FOV in Declination [deg]", + wxCMD_LINE_VAL_DOUBLE); AddOption(wxEmptyString,"scale","scale [deg/pix]",wxCMD_LINE_VAL_DOUBLE); - AddOption(wxEmptyString,"angle","rotation angle [deg], clockwise positive",wxCMD_LINE_VAL_DOUBLE); + AddOption(wxEmptyString,"angle","rotation angle [deg], clockwise positive", + wxCMD_LINE_VAL_DOUBLE); AddOption("","width","width of output [pix]",wxCMD_LINE_VAL_NUMBER); AddOption("","height","height of output [pix]",wxCMD_LINE_VAL_NUMBER); AddOption("","col-ra","Right Ascension column"); diff -Nru munipack-0.5.9/munipack/common.cpp munipack-0.5.10/munipack/common.cpp --- munipack-0.5.9/munipack/common.cpp 2017-07-17 23:03:48.000000000 +0000 +++ munipack-0.5.10/munipack/common.cpp 2018-01-16 17:58:04.000000000 +0000 @@ -10,12 +10,12 @@ it under the terms of the GNU General Public License as published by the Free Software Foundation, either version 3 of the License, or (at your option) any later version. - + Munipack is distributed in the hope that it will be useful, but WITHOUT ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the GNU General Public License for more details. - + You should have received a copy of the GNU General Public License along with Munipack. If not, see . @@ -121,7 +121,7 @@ void Munipack::CommonOptionsArith(MuniProcess *action, const MuniCmdLineParser& cmd) { - if( cmd.Found("a") ) + if( cmd.Found("arith") ) action->Write("MEAN = 'A'"); } @@ -136,13 +136,13 @@ while ( tokenizer.HasMoreTokens() ) { wxString token = tokenizer.GetNextToken(); - + wxRegEx rf("(.*)=(.*)"); wxASSERT(rf.IsValid()); if( rf.Matches(token) ) action->Write("ADDKEY = '"+rf.GetMatch(token,1)+"' '"+rf.GetMatch(token,2)+"'"); - else + else wxLogError("Option `"+token+"' unrecognized."); } } @@ -161,7 +161,7 @@ apstr(a,n,l); action->Write("NQUANTITIES = %d",n); action->Write("QUANTITIES = " + l); - } + } } void Munipack::apstr(const wxString& a, long& n, wxString& l) @@ -190,9 +190,9 @@ for(wxString::const_iterator c = filename.begin(); c != filename.end(); ++c ) { if( *c == '[' ) b++; - else if ( *c == ']' ) + else if ( *c == ']' ) b--; - else if( *c == ',' && b == 0 ) + else if( *c == ',' && b == 0 ) comma = c - filename.begin(); } @@ -209,7 +209,7 @@ else if ( advanced ) { backupname.Empty(); - newname.Empty(); + newname.Empty(); wxString xname, ext; FITSFileName::ParseExt(filename,xname,ext); @@ -217,11 +217,11 @@ if( format.IsEmpty() ) { wxRegEx rf(pattern); - + if( ! rf.IsValid() ) { wxLogError("Regular expression pattern `"+pattern+"' is invalid."); } - + if( rf.Matches(filename) ) { name = filename; @@ -243,7 +243,7 @@ name = filename; newname.Printf(format,++ncount); backupname = GetBackup(newname); - + } } else { @@ -257,7 +257,7 @@ newname = GetOutput(name); backupname = GetBackup(newname); } - + } } @@ -304,14 +304,14 @@ if( lstname.IsEmpty() ) { /* Input from standard input - + Use of the std.input interferes with running of external - utilities due to wxProcess.Redirect(). + utilities due to wxProcess.Redirect(). Much more worse is to read the input with help of wxTextInputStream which (in destructor) releases (detach, close) global program std. input (wxFile::fd_stdin) which - leads to crash (and random and undefined behavior) in MuniProcess + leads to crash (and random and undefined behavior) in MuniProcess at line: out << InputBuffer[i] << endl; @@ -328,7 +328,7 @@ wxFileName filename; filename.AssignTempFileName("munipack_stdin_"); - if( ! filename.IsOk() ) + if( ! filename.IsOk() ) wxLogFatalError("Failed to create a temp filename `"+filename.GetFullPath()+"'."); lstname = filename.GetFullPath(); @@ -345,7 +345,7 @@ } wxFileInputStream input(lstname); - if( ! input.IsOk() ) + if( ! input.IsOk() ) wxLogFatalError("Failed to open list file `"+lstname+"'."); wxTextInputStream text(input); @@ -361,9 +361,9 @@ } } - if( remove ) + if( remove ) wxRemoveFile(lstname); - + return true; } return false; @@ -403,7 +403,7 @@ bool Munipack::SetTargetDir(const wxString& t) -{ +{ target = t; // create the target directory if one doesn't exists @@ -414,4 +414,3 @@ else return d.Mkdir(wxS_DIR_DEFAULT,wxPATH_MKDIR_FULL); } - diff -Nru munipack-0.5.9/munipack/cone.cpp munipack-0.5.10/munipack/cone.cpp --- munipack-0.5.9/munipack/cone.cpp 2017-07-17 23:03:48.000000000 +0000 +++ munipack-0.5.10/munipack/cone.cpp 2018-01-16 17:58:04.000000000 +0000 @@ -80,7 +80,7 @@ if( cmd.Found("r",&r) || cmd.Found("radius",&r) ) pars["SR"] = wxString::FromCDouble(r); else - pars["SR"] = "0.01666666"; + pars["SR"] = "0.1"; if ( cmd.GetParamCount() != 2 ) wxLogFatalError("Unspecified position? Use: RA DEC (both in degress, sexadecimal)."); diff -Nru munipack-0.5.9/munipack/flat.cpp munipack-0.5.10/munipack/flat.cpp --- munipack-0.5.9/munipack/flat.cpp 2017-07-17 23:03:48.000000000 +0000 +++ munipack-0.5.10/munipack/flat.cpp 2018-01-16 17:58:04.000000000 +0000 @@ -2,7 +2,7 @@ Average of flats. - Copyright © 2010-2014 F.Hroch (hroch@physics.muni.cz) + Copyright © 2010-2014, 2017 F.Hroch (hroch@physics.muni.cz) This file is part of Munipack. @@ -10,12 +10,12 @@ it under the terms of the GNU General Public License as published by the Free Software Foundation, either version 3 of the License, or (at your option) any later version. - + Munipack is distributed in the hope that it will be useful, but WITHOUT ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the GNU General Public License for more details. - + You should have received a copy of the GNU General Public License along with Munipack. If not, see . @@ -32,9 +32,6 @@ double x; wxString a; - if( cmd.Found("level",&x) ) - action->Write("LEVEL = %lf",x); - if( cmd.Found("bias",&a) ) action->Write("BIAS = '"+a+"'"); @@ -44,20 +41,28 @@ if( cmd.Found("xdark",&x) ) action->Write("XDARK = %lf",x); + if( cmd.Found("bitmask",&a) ) + action->Write("MASK = '"+a+"'"); + if( cmd.Found("gain",&x) ) action->Write("GAIN = %lf",x); - if( cmd.Found("saturate",&x) ) + if( cmd.Found("st",&x) || cmd.Found("saturate",&x) ) action->Write("SATURATE = %lf",x); + if( cmd.Found("th",&x) || cmd.Found("threshold",&x) ) + action->Write("THRESHOLD = %lf",x); + if( cmd.Found("gain-estimate") ) { action->Write("GAIN_ESTIMATE = T"); action->Write("VERBOSE = T"); } + if( cmd.Found("approximation",&a) ) + action->Write("APPROXIMATION = '"+a+"'"); + for(size_t i = 0; i < cmd.GetParamCount(); i++) WriteFile(action,cmd.GetParam(i)); return true; } - diff -Nru munipack-0.5.9/munipack/kombine.cpp munipack-0.5.10/munipack/kombine.cpp --- munipack-0.5.9/munipack/kombine.cpp 2017-07-17 23:03:48.000000000 +0000 +++ munipack-0.5.10/munipack/kombine.cpp 2018-01-16 17:58:04.000000000 +0000 @@ -2,7 +2,7 @@ Kombine - Copyright © 2011-3 F.Hroch (hroch@physics.muni.cz) + Copyright © 2011-3, 2017 F.Hroch (hroch@physics.muni.cz) This file is part of Munipack. @@ -10,12 +10,12 @@ it under the terms of the GNU General Public License as published by the Free Software Foundation, either version 3 of the License, or (at your option) any later version. - + Munipack is distributed in the hope that it will be useful, but WITHOUT ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the GNU General Public License for more details. - + You should have received a copy of the GNU General Public License along with Munipack. If not, see . @@ -27,13 +27,13 @@ bool Munipack::kombine(MuniProcess *action, MuniCmdLineParser& cmd) { - CommonOutputSingle(action,cmd); - CommonOptionsBitpix(action,cmd); - double x,y; long w,h; wxString a; + CommonOutputSingle(action,cmd); + CommonOptionsBitpix(action,cmd); + if( cmd.Found("p",&a) || cmd.Found("projection",&a) ) action->Write("PROJECTION = '" + a.Upper() + "'"); @@ -52,6 +52,12 @@ if( cmd.Found("angle",&x) ) action->Write("ANGLE = %20.15f",x); + if( cmd.Found("reflex",&a) ) { + a.MakeUpper(); + wxString reflex = a.Find("Y") != wxNOT_FOUND ? "T" : "F"; + action->Write("REFLEX = " + reflex); + } + if( cmd.Found("i",&a) || cmd.Found("interpol",&a) ) action->Write("INTERPOL = '" + a + "'"); @@ -61,6 +67,9 @@ if( cmd.Found("expomask") ) action->Write("EXPOMASK = T"); + if( cmd.Found("average") ) + action->Write("AVERAGE = T"); + // a FILE *follows* all the above if( cmd.GetParamCount() > 0 ) { action->Write("NFILES = %d",static_cast(cmd.GetParamCount())); diff -Nru munipack-0.5.9/munipack/Makefile.in munipack-0.5.10/munipack/Makefile.in --- munipack-0.5.9/munipack/Makefile.in 2017-07-17 23:04:25.000000000 +0000 +++ munipack-0.5.10/munipack/Makefile.in 2018-01-16 17:58:15.000000000 +0000 @@ -335,7 +335,6 @@ builddir = @builddir@ datadir = @datadir@ datarootdir = @datarootdir@ -develop = @develop@ docdir = @docdir@ dvidir = @dvidir@ exec_prefix = @exec_prefix@ diff -Nru munipack-0.5.9/munipack/munipack.1 munipack-0.5.10/munipack/munipack.1 --- munipack-0.5.9/munipack/munipack.1 2017-07-17 23:03:48.000000000 +0000 +++ munipack-0.5.10/munipack/munipack.1 2018-01-16 17:58:04.000000000 +0000 @@ -1,17 +1,17 @@ \" t -.TH MUNIPACK 1 "June 2013" "Munipack" "User Commands" +.TH MUNIPACK 1 "June 2013" "Munipack" "User Commands" .SH NAME munipack \- command line interface for Munipack .SH SYNOPSIS -.B munipack +.B munipack .I [options] action file(s) .SH DESCRIPTION Munipack is a general astronomical image processing software. -This utility provides the command line interface for +This utility provides the command line interface for all features of Munipack. .PP The detailed description is very extensible and can be found -in HTML documentation. There are summarized just help related options. +in HTML documentation. There are summarized just help related options. A short help list is build-in. .SH OPTIONS .TP @@ -21,15 +21,10 @@ .B \-\-version Print version and license. .SH COPYRIGHT -Copyright © 2009-2016 Filip Hroch . +Copyright © 2009-2016 Filip Hroch . License GPLv3+: GNU GPL version 3 or later This is free software: you are free to change and redistribute it. There is NO WARRANTY, to the extent permitted by law. .SH SEE ALSO -xmunipack(1), http://munipack.physics.muni.cz/ -.PP -file:///opt/munipack/share/doc/munipack/html/ -.PP -file:///usr/local/share/doc/html/munipack/html/ - +xmunipack(1), http://munipack.physics.muni.cz/, /usr/share/doc/munipack diff -Nru munipack-0.5.9/munipack/munipack.cpp munipack-0.5.10/munipack/munipack.cpp --- munipack-0.5.9/munipack/munipack.cpp 2017-07-17 23:03:48.000000000 +0000 +++ munipack-0.5.10/munipack/munipack.cpp 2018-01-16 17:58:04.000000000 +0000 @@ -126,7 +126,7 @@ else { if( cmd.Found("version") ) { - wxPrintf("%s %s, %s\n%s\n\n",INFOTEXT,XVERSION,COPYLEFT,INFOTEXTFULL); + wxPrintf("%s %s, %s\n%s\n",INFOTEXT,XVERSION,COPYLEFT,INFOTEXTFULL); wxPrintf("Munipack comes with ABSOLUTELY NO WARRANTY.\n"); wxPrintf("You may redistribute copies of Munipack\n"); wxPrintf("under the terms of the GNU General Public License.\n"); diff -Nru munipack-0.5.9/munipack/phcal.cpp munipack-0.5.10/munipack/phcal.cpp --- munipack-0.5.9/munipack/phcal.cpp 2017-07-17 23:03:48.000000000 +0000 +++ munipack-0.5.10/munipack/phcal.cpp 2018-01-16 17:58:04.000000000 +0000 @@ -2,7 +2,7 @@ Photometrical calibration - Copyright © 2012-6 F.Hroch (hroch@physics.muni.cz) + Copyright © 2012-7 F.Hroch (hroch@physics.muni.cz) This file is part of Munipack. @@ -10,12 +10,12 @@ it under the terms of the GNU General Public License as published by the Free Software Foundation, either version 3 of the License, or (at your option) any later version. - + Munipack is distributed in the hope that it will be useful, but WITHOUT ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the GNU General Public License for more details. - + You should have received a copy of the GNU General Public License along with Munipack. If not, see . @@ -107,6 +107,15 @@ if( cmd.Found("saper",&n) ) action->Write("SAPER = %ld",n); + if( cmd.Found("th",&x) || cmd.Found("threshold",&x)) + action->Write("THRESHOLD = %e",x); + + if( cmd.Found("e",&x) || cmd.Found("maxerr",&x)) + action->Write("MAXERR = %e",x); + + if( cmd.Found("apcorr",&x)) + action->Write("APCORR = %e",x); + if( cmd.Found("C",&a) || cmd.Found("cal",&a) ) { long n; apstr(a,n,c); @@ -124,12 +133,12 @@ if( cmd.Found("col-ra",&a) ) action->Write("COL_RA = '" + a + "'"); - else if( cat.IsOk() ) + else if( cat.IsOk() ) action->Write("COL_RA = '" + cat.GetLabel("POS_EQ_RA") + "'"); if( cmd.Found("col-dec",&a) ) action->Write("COL_DEC = '" + a + "'"); - else if( cat.IsOk() ) + else if( cat.IsOk() ) action->Write("COL_DEC = '" + cat.GetLabel("POS_EQ_DEC") + "'"); action->Write("CAT = '" + c + "'"); diff -Nru munipack-0.5.9/munipack/votable.cpp munipack-0.5.10/munipack/votable.cpp --- munipack-0.5.9/munipack/votable.cpp 2017-07-17 23:03:48.000000000 +0000 +++ munipack-0.5.10/munipack/votable.cpp 2018-01-16 17:58:04.000000000 +0000 @@ -2,7 +2,7 @@ VO Table manipulations - Copyright © 2011-3,5 F.Hroch (hroch@physics.muni.cz) + Copyright © 2011-3,5,7 F.Hroch (hroch@physics.muni.cz) This file is part of Munipack. @@ -10,12 +10,12 @@ it under the terms of the GNU General Public License as published by the Free Software Foundation, either version 3 of the License, or (at your option) any later version. - + Munipack is distributed in the hope that it will be useful, but WITHOUT ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the GNU General Public License for more details. - + You should have received a copy of the GNU General Public License along with Munipack. If not, see . @@ -36,6 +36,7 @@ wxString a, type; double x; + long l; if( cmd.Found("o",&a) || cmd.Found("output",&a) ) { wxFileName fn(a); @@ -61,6 +62,12 @@ if( cmd.Found("pd",&x) ) action->Write("PROJ DELTA = %lf",x); + if( cmd.Found("pw",&l) ) + action->Write("PROJ WIDTH = %ld",l); + + if( cmd.Found("ph",&l) ) + action->Write("PROJ HEIGHT = %ld",l); + if( cmd.Found("ps",&x) ) action->Write("PROJ SCALE = %lf",x); diff -Nru munipack-0.5.9/photometry/aphot.f95 munipack-0.5.10/photometry/aphot.f95 --- munipack-0.5.9/photometry/aphot.f95 2017-07-17 23:03:48.000000000 +0000 +++ munipack-0.5.10/photometry/aphot.f95 2018-01-16 17:58:04.000000000 +0000 @@ -1,7 +1,7 @@ ! ! aperture photometry ! -! Copyright © 2010-16 F.Hroch (hroch@physics.muni.cz) +! Copyright © 2010-17 F.Hroch (hroch@physics.muni.cz) ! ! This file is part of Munipack. ! @@ -9,12 +9,12 @@ ! it under the terms of the GNU General Public License as published by ! the Free Software Foundation, either version 3 of the License, or ! (at your option) any later version. -! +! ! Munipack is distributed in the hope that it will be useful, ! but WITHOUT ANY WARRANTY; without even the implied warranty of ! MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the ! GNU General Public License for more details. -! +! ! You should have received a copy of the GNU General Public License ! along with Munipack. If not, see . @@ -23,7 +23,6 @@ use fitsio use fitsaphot - use mdaosky use mdaofotometr implicit none @@ -34,7 +33,7 @@ real, dimension(2) :: ring logical :: verbose = .false., plog = .false. integer :: i,eq,status,naper - + ! we predefine radii of apertures as the logarithmic spiral, ! pitch 9.84 deg, apertures(1) = 1, .. apertures(12) = 20 allocate(apertures(12)) diff -Nru munipack-0.5.9/photometry/calibre.f95 munipack-0.5.10/photometry/calibre.f95 --- munipack-0.5.9/photometry/calibre.f95 2017-07-17 23:03:48.000000000 +0000 +++ munipack-0.5.10/photometry/calibre.f95 2018-01-16 17:58:03.000000000 +0000 @@ -1,7 +1,7 @@ ! ! photometric calibration ! -! Copyright © 2012 - 2015 F.Hroch (hroch@physics.muni.cz) +! Copyright © 2012-15, 2017 F.Hroch (hroch@physics.muni.cz) ! ! This file is part of Munipack. ! @@ -9,17 +9,16 @@ ! it under the terms of the GNU General Public License as published by ! the Free Software Foundation, either version 3 of the License, or ! (at your option) any later version. -! +! ! Munipack is distributed in the hope that it will be useful, ! but WITHOUT ANY WARRANTY; without even the implied warranty of ! MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the ! GNU General Public License for more details. -! +! ! You should have received a copy of the GNU General Public License ! along with Munipack. If not, see . - module calibre implicit none @@ -74,7 +73,7 @@ logical, intent(in) :: verbose real(dbl),dimension(:,:),allocatable :: ct, dct - real(dbl),dimension(:,:),allocatable :: relerr + real(dbl),dimension(:,:),allocatable :: relerr integer :: i,n,ndat,npht ndat = size(pht,1) @@ -97,7 +96,7 @@ do n = 1, npht relerr(:,n) = (pht(:,n) - ct(:,n))/pht(:,n) end do - + phres(:)%ctph = ctph phres(:)%dctph = dctph @@ -139,17 +138,17 @@ ph(:) = pht(:,n) dph(:) = dpht(:,n) - where( dph < epsilon(dph) ) + where( ph > 0 .and. dph < epsilon(dph) ) dph = sqrt(ph) end where - where( dct < epsilon(dct) ) + where( ct > 0 .and. dct < epsilon(dct) ) dct = sqrt(ct) end where call rcal(ph,dph,ct,dct,ctph(n),dctph(n),verbose) - relerr(:,n) = (ph - ctph(n)*ct) / ph - + relerr(:,n) = (ph - ctph(n)*ct) / ((ph + ctph(n)*ct) / 2) + end do phres(:)%ctph = ctph @@ -167,4 +166,3 @@ end module calibre - diff -Nru munipack-0.5.9/photometry/daofotometr.f95 munipack-0.5.10/photometry/daofotometr.f95 --- munipack-0.5.9/photometry/daofotometr.f95 2017-07-17 23:03:48.000000000 +0000 +++ munipack-0.5.10/photometry/daofotometr.f95 2018-01-16 17:58:04.000000000 +0000 @@ -1,6 +1,6 @@ ! ! PHOTOMETRY, aperture photometry -! Copyright (C) 1997-9,2010,2013-16 Filip Hroch, Masaryk University +! Copyright (C) 1997-9,2010,2013-17 Filip Hroch, Masaryk University ! Copyright (C) 1991 P.B. Stetson, Dominon Astrophysical Observatory ! ! @@ -9,8 +9,9 @@ ! Credits ! ! Almost all this source is authored by P. B. Stetson. -! I just adapted it for Fortran 90 (allocatable arrays, precision, -! array syntax) +! I adapted it for Fortran 90 (allocatable arrays, precision, +! array syntax), corrected errors, improve sky estimate by +! variance stabilising estimator. ! ! ! Munipack is free software: you can redistribute it and/or modify @@ -34,16 +35,18 @@ contains -subroutine daophotsb (d, stddev,xstar,ystar,hstar,raper,ring,lobad,hibad,phpadu, & +subroutine daophotsb (d, stderr,xstar,ystar,hstar,raper,ring,lobad,hibad,phpadu, & verbose,plog,apcts,apcts_err,xsky,xsky_err,status) !watch, coofil, magfil) use iso_fortran_env use robustmean + use weightedmean + use medians implicit none - real, dimension(:,:), intent(in) :: d,stddev + real, dimension(:,:), intent(in) :: d,stderr real, dimension(:), intent(in) :: xstar, ystar, hstar, raper,ring real, dimension(:,:), intent(out) :: apcts,apcts_err real, dimension(:), intent(out) :: xsky,xsky_err @@ -94,7 +97,7 @@ real(precision) :: maglim, magsq, wt, sumwt real(precision) :: apmag(size(raper)), area(size(raper)), sdev(size(raper)) !!! real(precision) :: apmag(maxap), area(maxap) - real, dimension(:), allocatable :: sky + real, dimension(:), allocatable :: sky, dsky real :: error(3), magerr(size(raper)) !magerr(maxap) !!! real :: par(maxap+2) = 0.0 !!! real :: pmin(maxap+2) = tiny(0.0) @@ -110,6 +113,7 @@ integer :: i, j, k, n, naper, nmag, lx, ly, nx, ny ! integer :: istar, mx, my, nsky, nl, maxsky, ncol, nrow integer :: istar, mx, my, nsky, maxsky, ncol, nrow + logical :: reliable status = 0 @@ -184,7 +188,7 @@ !!! allocate(sky(maxsky)) maxsky = int(max(pi*((ring(2)+1)**2 - ring(1)**2),1.5)) - allocate(sky(maxsky)) + allocate(sky(maxsky),dsky(maxsky)) ! ! NAPER is the number of apertures, whose radii are stored in @@ -331,6 +335,7 @@ (datum > hibad))) then nsky = nsky + 1 sky(nsky) = datum + dsky(nsky) = stderr(i,j) endif ! ! The inclusion of partial pixels inside the aperture is done as @@ -370,7 +375,7 @@ if (datum < lobad .or. datum > hibad ) apmag(k) = - huge(1.0) apmag(k) = apmag(k) + fractn*datum area(k) = area(k) + fractn - sdev(k) = sdev(k) + fractn**2 * stddev(i,j)**2 + sdev(k) = sdev(k) + fractn * stderr(i,j)**2 endif enddo endif @@ -407,8 +412,18 @@ ! ! call mmm (sky, nsky, hibad, dum, datum, skymod, skysig, skyskw) !!! call robustmean1(sky, nsky, skymn, skymed, skymod, skysig, skyskw) - call rmean(sky(1:nsky),skymod,skyerr,skysig) -! write(*,*) nsky,skymod,skyerr,skysig,apmag + + if( all(sky(1:nsky) > 0) .and. all(dsky(1:nsky) > 0) ) then + call rwmean(sky(1:nsky),dsky(1:nsky),skymod,skyerr,skysig,& + reliable=reliable) + ! write(*,*) nsky,skymod,skyerr,skysig + else + reliable = .false. + end if + if( .not. reliable ) then + call rmean(sky(1:nsky),skymod,skyerr,skysig) +! write(*,*) skymod,skysig + end if skyvar=skysig**2 sigsq=skyvar/nsky @@ -437,13 +452,15 @@ ! in the star aperture, set the magnitude to 99.999. ! if (apmag(i) <= 0.0) go to 2210 - error(1) = real(area(i)*skyvar) +! error(1) = real(area(i)*skyvar) + error(1) = real(area(i)*skyerr**2) error(2) = real(apmag(i))!*phpadu!/phpadu error(3) = real(sigsq*area(i)**2) - ! in Munipack, the noise of flat-field (and others) is already included: - error(1) = real(sdev(i)) - error(3) = epsilon(error) +! error(1) = real(sdev(i) + error(1)) / 2 +! error(3) = epsilon(error) + +! write(*,'(5g15.3)') apmag(i),area(i),area(i)*skyvar,sdev(i),sigsq*area(i)**2 ! readns ????? @@ -452,7 +469,11 @@ ! data. apcts(n,i) = real(apmag(i)*phpadu) - apcts_err(n,i) = sqrt(phpadu*(error(1) + error(2) + error(3))) + ! in Munipack, the noise of flat-field (and others) is also included: + apcts_err(n,i) = real(sqrt(error(1) + error(2) + error(3))) + ! apcts_err(n,i) = sqrt(phpadu*(error(1) + error(2) + error(3) + sdev(i)**2)) +! write(*,*) sqrt(error(1)), sqrt(error(2)), sqrt(error(3)),stderr(int(xc),int(yc))!sqrt(sdev(i)) +! apcts_err(n,i) = sqrt(apmag(i)) ! ! These variables ERRORn are the respective variances (squares of the @@ -535,7 +556,7 @@ !----------------------------------------------------------------------- ! !666 continue -if ( allocated(sky) ) deallocate(sky) +if ( allocated(sky) ) deallocate(sky,dsky) status = 1 end subroutine daophotsb diff -Nru munipack-0.5.9/photometry/fitsaphot.f95 munipack-0.5.10/photometry/fitsaphot.f95 --- munipack-0.5.9/photometry/fitsaphot.f95 2017-07-17 23:03:48.000000000 +0000 +++ munipack-0.5.10/photometry/fitsaphot.f95 2018-01-16 17:58:04.000000000 +0000 @@ -46,7 +46,7 @@ real, parameter :: nullval = 0.0 integer, dimension(DIM) :: naxes logical :: anyf - real, dimension(:,:), allocatable :: data, stddev + real, dimension(:,:), allocatable :: data, stderr real, dimension(:), allocatable :: xcens,ycens,hstar,sky,sky_err real, dimension(:,:), allocatable :: apcts,apcts_err character(len=FLEN_VALUE), dimension(:), allocatable :: ttype, tform, tunit @@ -59,17 +59,23 @@ call ftgipr(15,DIM,bitpix,naxis,naxes,status) if( status /= 0 ) goto 666 - allocate(data(naxes(1),naxes(2)),stddev(naxes(1),naxes(2))) + allocate(data(naxes(1),naxes(2)),stderr(naxes(1),naxes(2))) call ftg2de(15,group,nullval,size(data,1),naxes(1),naxes(2),data,anyf,status) call ftmnhd(15,IMAGE_HDU,EXT_STDERR,extver,status) if( status == 0 ) then - call ftg2de(15,1,nullval,naxes(1),naxes(1),naxes(2),stddev,anyf,status) + call ftg2de(15,1,nullval,naxes(1),naxes(1),naxes(2),stderr,anyf,status) else if ( status == BAD_HDU_NUM ) then ! if the information about standard error is not available, ! we are continuing with epsilons ! if( verbose ) write(error_unit,*) "Standard errors of frame are not available." - stddev = epsilon(stddev) + ! stderr = epsilon(stderr) + ! we are continuing with only Poisson component + where( data > 0 ) + stderr = sqrt(data) + elsewhere + stderr = -1 + end where status = 0 end if @@ -113,7 +119,7 @@ if( status /= 0 ) goto 666 ! aperture photometry - call daophotsb(data,stddev,xcens,ycens,hstar,raper,ring,lobad,hibad,1.0, & + call daophotsb(data,stderr,xcens,ycens,hstar,raper,ring,lobad,hibad,1.0, & verbose,plog,apcts,apcts_err,sky,sky_err,status) if( status /= 0 ) goto 666 @@ -175,7 +181,7 @@ 666 continue - if( allocated(data) ) deallocate(data,stddev) + if( allocated(data) ) deallocate(data,stderr) if( allocated(apcts) ) deallocate(xcens,ycens,hstar,apcts,apcts_err, & sky,sky_err) diff -Nru munipack-0.5.9/photometry/gphot.f95 munipack-0.5.10/photometry/gphot.f95 --- munipack-0.5.9/photometry/gphot.f95 2017-07-17 23:03:48.000000000 +0000 +++ munipack-0.5.10/photometry/gphot.f95 2018-01-16 17:58:04.000000000 +0000 @@ -1,7 +1,7 @@ ! ! grow-curve photometry ! -! Copyright © 2016 F.Hroch (hroch@physics.muni.cz) +! Copyright © 2016-7 F.Hroch (hroch@physics.muni.cz) ! ! This file is part of Munipack. ! @@ -30,7 +30,7 @@ character(len=FLEN_FILENAME) :: outname, file,backup, output = '' logical :: verbose = .false., plog = .false. integer :: eq,status - real :: threshold = 7 + real :: threshold = 0.1 do read(*,'(a)',end=20) record @@ -110,8 +110,8 @@ call ftmnhd(15,BINARY_TBL,APEREXTNAME,extver,status) if( status == BAD_HDU_NUM ) then write(error_unit,*) "Error: ",trim(APEREXTNAME)// & - " extension not found. Has been aperture photometry by " - write(error_unit,*) " `munipack aphot "//trim(filename)//"' performed?" + " extension not found. Has been aperture photometry by " // & + "`munipack aphot "//trim(filename)//"' performed?" goto 666 end if diff -Nru munipack-0.5.9/photometry/growcurve.f95 munipack-0.5.10/photometry/growcurve.f95 --- munipack-0.5.9/photometry/growcurve.f95 2017-07-17 23:03:48.000000000 +0000 +++ munipack-0.5.10/photometry/growcurve.f95 2018-01-16 17:58:04.000000000 +0000 @@ -24,6 +24,10 @@ ! along with Munipack. If not, see . ! +! grow curve construction: +! * localy (en every point), the variartion principle +! must be satisfied, base funtions be linear? + module grow_curve @@ -117,7 +121,7 @@ real(dbl), dimension(:,:), allocatable :: grow,grow_err!,grows,grows_err integer, dimension(:), allocatable :: id, idn - integer :: nid,nrows,naper,i,nhwhm + integer :: nid,nrows,naper,i,nhwhm,maper ! real(dbl) :: y1,y2,x2,x1,a,b,gx nrows = size(apcts,1) @@ -137,9 +141,20 @@ ! end do ! stop 0 + ! select aperture optimal for star selection procedure + maper = 0 + do i = 1,naper + if( raper(i) >= 2*hwhm ) then + maper = i + exit + end if + end do + if( maper == 0 ) goto 666 + ! select isolated stars with all aperture measurements valid - call select_valid_isolated(xcens,ycens,sep,threshold,apcts,apcts_err,sky_err, & - raper(naper),nid,id) + call select_valid_isolated(xcens,ycens,sep,threshold,apcts,apcts_err,sky, & + raper(maper),maper,nid,id) +! write(*,*) nid,maper if( nid == 0 ) goto 666 ! ** WARNING ** @@ -221,8 +236,8 @@ end subroutine growcurve - subroutine select_valid_isolated(xcens,ycens,sep,threshold,apcts,apcts_err,sky_err, & - raper,nid,id) + subroutine select_valid_isolated(xcens,ycens,sep,threshold,apcts,apcts_err,& + sky,raper,maper,nid,id) ! select isolated stars suitable for estimate of growth-curve ! @@ -231,9 +246,10 @@ ! * all measurements are valid ! * bright stars - real, dimension(:), intent(in) :: xcens,ycens,sky_err + real, dimension(:), intent(in) :: xcens,ycens,sky real, intent(in) :: sep, threshold, raper real, dimension(:,:), intent(in) :: apcts, apcts_err + integer, intent(in) :: maper integer, intent(out) :: nid integer, dimension(:), intent(out) :: id @@ -260,14 +276,15 @@ end do 90 continue - ! accept only ones with valid measurements in all apertures - if( .not. found .and. all(apcts(i,:) > 0) .and. all(apcts_err(i,:) > 0) ) then + ! accept only valid bright stars highly above sky limit +! write(*,*) apcts(i,maper)/(aper*sky(i)),threshold,found + if( .not. found .and. & + all(apcts(i,:) > 0) .and. all(apcts_err(i,:) > 0) .and. & + apcts(i,maper) / (aper*sky(i)) > threshold ) then + + nid = nid + 1 + id(nid) = i - ! accept only bright stars, the limit is threshold * aperture area * sky error - if( apcts(i,naper) > threshold*sky_err(i)*aper ) then - nid = nid + 1 - id(nid) = i - end if end if end do @@ -514,8 +531,9 @@ if( n > nhwhm + 1 ) then ! a = apcount(i) -! aerr = apcount_err(i) - call rcal(cts(:n),dcts(:n),curve(:n),curve_err(:n),a,aerr,.false.) ! only 1:nhwhm ? + ! aerr = apcount_err(i) + call rcal(cts(:n),dcts(:n),curve(:n),curve_err(:n),a,aerr,.false.) + ! only 1:nhwhm ? call growfit(r(1:n),cts(1:n),dcts(1:n),c(1:n),dc(1:n),sky_sig(i), & a,aerr,b,berr,sig,info) if( info == 0 ) then diff -Nru munipack-0.5.9/photometry/growfit.f95 munipack-0.5.10/photometry/growfit.f95 --- munipack-0.5.9/photometry/growfit.f95 2017-07-17 23:03:48.000000000 +0000 +++ munipack-0.5.10/photometry/growfit.f95 2018-01-16 17:58:04.000000000 +0000 @@ -32,7 +32,7 @@ logical, parameter, private :: analytic = .true. ! verbose (prints intermediate results) - logical, parameter, private :: verbose = .true. + logical, parameter, private :: verbose = .false. ! In minpacks routines, prints intermediate results every nprint-call or be quite (0) integer, private :: nprint = 0 ! 0 or >= 1 diff -Nru munipack-0.5.9/photometry/growmodel.f95 munipack-0.5.10/photometry/growmodel.f95 --- munipack-0.5.9/photometry/growmodel.f95 2017-07-17 23:03:48.000000000 +0000 +++ munipack-0.5.10/photometry/growmodel.f95 2018-01-16 17:58:04.000000000 +0000 @@ -1708,7 +1708,8 @@ tol = 1e-7 bmin = 0 !epsilon(b) ! bmax = 1.0/20.**2!00 -! bmax = maxval(grows(n,nref:naper-1)/ + ! bmax = maxval(grows(n,nref:naper-1)/ + bmax = max(bmax,bmin+tol) b = fmin(bmin,bmax,arcfun,tol) ! write(*,*) bmin,b,bmax b = b*raper(naper)**2 diff -Nru munipack-0.5.9/photometry/jam.f95 munipack-0.5.10/photometry/jam.f95 --- munipack-0.5.9/photometry/jam.f95 2017-07-17 23:03:48.000000000 +0000 +++ munipack-0.5.10/photometry/jam.f95 2018-01-16 17:58:03.000000000 +0000 @@ -1,7 +1,7 @@ ! ! Merging of photometric catalogues ! -! Copyright © 2013 - 16 F.Hroch (hroch@physics.muni.cz) +! Copyright © 2013-7 F.Hroch (hroch@physics.muni.cz) ! ! This file is part of Munipack. ! @@ -25,8 +25,6 @@ integer, parameter, private :: dbl = selected_real_kind(15) real(dbl), parameter, private :: rad = 57.295779513082322865_dbl -! logical, private :: verbose = .true. - contains @@ -71,6 +69,7 @@ cosr = sin(d1/rad)*sin(d2/rad) + cos(d1/rad)*cos(d2/rad)*cos((a1 - a2)/rad) spmetr = rad*acos(min(cosr,1.0_dbl)) +! spmetr = sqrt((d1 - d2)**2 + cos((a1+a2)/2/rad)**2*(a1 - a2)**2) end function spmetr @@ -162,12 +161,16 @@ real(dbl), allocatable, dimension(:) :: refra,refdec,xra,xdec,adu,dadu,exptime,areas real(dbl), allocatable, dimension(:,:) :: mag,dmag, xcts,xdcts - real(dbl) :: ftol,tol,w + real(dbl) :: ftol,tol,w, aper integer, dimension(:), allocatable :: id type(type_phsys), dimension(:), allocatable :: phsyscal type(type_phsys) :: phsys integer :: status,nfiles,ncat,ncols,j,n,l + ! setup to prove + real(dbl), parameter :: waterline = 5 + real(dbl), parameter :: maxerr = 0.1 + call readcat(cat,(/col_ra,col_dec/),col_mag,col_magerr, & refra,refdec,mag,dmag,catid,status) @@ -185,9 +188,9 @@ allocate(exptime(nfiles),areas(nfiles),filter(nfiles),airmass(nfiles)) do n = 1, nfiles - call readframe(filename(n),keys,xra,xdec,adu,dadu,ftol,& - exptime(n),areas(n),photosys_instr,filter(n), & - init_area,0,status,airmass(n)) + call readframe(filename(n),keys,waterline,maxerr,xra,xdec,adu,dadu,& + ftol,exptime(n),areas(n),photosys_instr,filter(n), & + init_area,0,aper,status,airmass(n)) ! SAPER=0 is set at any case, only apperture corrected data are used ! if( status /= 0 ) then @@ -387,7 +390,8 @@ real(dbl), dimension(:), intent(in) :: tol real(dbl), dimension(:), intent(in out) :: refra, refdec - real(dbl), dimension(:,:), allocatable, intent(in out) :: ra,dec, refph, drefph, cts, dcts + real(dbl), dimension(:,:), allocatable, intent(in out) :: ra,dec, & + refph, drefph, cts, dcts ! real(dbl), dimension(:,:), intent(in) :: dn,ddn, ra, dec ! real(dbl), dimension(:,:), allocatable, intent(out) :: cts,dcts @@ -414,7 +418,7 @@ do l = 1,nref if( id(l) > 0 ) then j = id(l) - if( cts(j,n) > epsilon(cts) .and. refph(l,n) > epsilon(refph) ) then + if( cts(j,n) > 0 .and. refph(l,n) > 0 ) then xcts(l,n) = cts(j,n) xdcts(l,n) = dcts(j,n) end if @@ -427,7 +431,7 @@ ! select just valid records nref = 0 do j = 1,size(refph,1) - if( all(xcts(j,:) > epsilon(xcts)) .and. all(refph(j,:) > epsilon(refph)) ) then + if( all(xcts(j,:) > 0) .and. all(refph(j,:) > 0) ) then ! if( all(sqrt(xcts(j,:))/xcts(j,:) < 0.01) ) then nref = nref + 1 refra(nref) = refra(j) diff -Nru munipack-0.5.9/photometry/Makefile.in munipack-0.5.10/photometry/Makefile.in --- munipack-0.5.9/photometry/Makefile.in 2017-07-17 23:04:25.000000000 +0000 +++ munipack-0.5.10/photometry/Makefile.in 2018-01-16 17:58:15.000000000 +0000 @@ -335,7 +335,6 @@ builddir = @builddir@ datadir = @datadir@ datarootdir = @datarootdir@ -develop = @develop@ docdir = @docdir@ dvidir = @dvidir@ exec_prefix = @exec_prefix@ diff -Nru munipack-0.5.9/photometry/mfits.f95 munipack-0.5.10/photometry/mfits.f95 --- munipack-0.5.9/photometry/mfits.f95 2017-07-17 23:03:48.000000000 +0000 +++ munipack-0.5.10/photometry/mfits.f95 2018-01-16 17:58:04.000000000 +0000 @@ -27,6 +27,7 @@ integer, parameter, private :: dbl = selected_real_kind(15) real(dbl), parameter, private :: rad = 57.295779513082322865_dbl + real(dbl), parameter, private :: pi = 3.14159265359_dbl logical, private :: verbose = .true. @@ -112,8 +113,9 @@ end subroutine readcat - subroutine readframe(filename,keys,alpha,delta,cts,dcts,ftol,exptime,area, & - photosys,filter,init_area,saper,status,amass) + subroutine readframe(filename,keys,threshold,maxerr,alpha,delta,cts,dcts, & + ftol,exptime,area,photosys,filter,init_area,saper,aper,status,& + amass) use astrotrafo use astrosphere @@ -122,11 +124,13 @@ character(len=*), intent(in) :: filename character(len=*), dimension(:), intent(in) :: keys + real(dbl), intent(in) :: threshold, maxerr real(dbl), dimension(:), allocatable, intent(out) :: alpha,delta,cts,dcts real(dbl), intent(out) :: ftol,exptime, area character(len=*), intent(out) :: photosys,filter logical, intent(in) :: init_area integer, intent(in) :: saper + real(dbl), intent(out) :: aper integer, intent(out) :: status real(dbl), optional, intent(out) :: amass @@ -134,13 +138,15 @@ integer, parameter :: felem = 1 integer, parameter :: DIM = 2 integer, dimension(DIM) :: naxes - integer :: naxis, nrows, colnum, naper, maper, s1, s2, s4, s5, yy,m,d,hour,min, i - real(dbl) :: year, month, day, sec, jd, longitude, latitude + integer :: naxis, nrows, colnum, naper, maper, s1, s2, s4, s5, & + yy,m,d,hour,min, i, j, nid + real(dbl) :: year, month, day, sec, jd, longitude, latitude, spot character(len=FLEN_COMMENT) :: com character(len=FLEN_CARD) :: key, keycts, keyerr - real(dbl), dimension(:), allocatable :: x,y + real(dbl), dimension(:), allocatable :: x,y,sky,ct,dct + integer, dimension(:), allocatable :: id real(dbl) :: nullval - real :: hwhm, aper + real :: hwhm logical :: anyf logical :: undef_airmass, have_grow, have_ap type(AstroTrafoProj) :: tproj @@ -294,6 +300,7 @@ if( have_grow .and. saper == 0 ) then keycts = FITS_COL_GCOUNT keyerr = FITS_COL_GCOUNTERR + call ftgkyd(20,FITS_KEY_RF90,aper,com,status) end if if( (.not. have_grow .and. have_ap) .or. (have_ap .and. saper > 0) ) then @@ -302,12 +309,14 @@ if( saper > 0 ) then maper = saper + call ftkeyn(FITS_KEY_APER,maper,key,status) + call ftgkyd(20,key,aper,com,status) else call ftgkyj(20,FITS_KEY_NAPER,naper,com,status) do i = 1, naper call ftkeyn(FITS_KEY_APER,i,key,status) - call ftgkye(20,key,aper,com,status) - if( aper > 3*hwhm ) then + call ftgkyd(20,key,aper,com,status) + if( aper > 2*hwhm ) then maper = i exit end if @@ -322,25 +331,46 @@ call ftgnrw(20,nrows,status) if( status /= 0 ) goto 666 - allocate(x(nrows),y(nrows)) + allocate(x(nrows),y(nrows),sky(nrows),ct(nrows),dct(nrows)) ! table call ftgcno(20,.true.,FITS_COL_X,colnum,status) call ftgcvd(20,colnum,frow,felem,nrows,nullval,x,anyf,status) call ftgcno(20,.true.,FITS_COL_Y,colnum,status) call ftgcvd(20,colnum,frow,felem,nrows,nullval,y,anyf,status) - - if( status == 0 ) then - allocate(alpha(nrows), delta(nrows)) - call invtrafo(tproj,x,y,alpha,delta) - end if - deallocate(x,y) - - allocate(cts(nrows),dcts(nrows)) + call ftgcno(20,.true.,FITS_COL_SKY,colnum,status) + call ftgcvd(20,colnum,frow,felem,nrows,nullval,sky,anyf,status) call ftgcno(20,.true.,keycts,colnum,status) - call ftgcvd(20,colnum,frow,felem,nrows,nullval,cts,anyf,status) + call ftgcvd(20,colnum,frow,felem,nrows,nullval,ct,anyf,status) call ftgcno(20,.true.,keyerr,colnum,status) - call ftgcvd(20,colnum,frow,felem,nrows,nullval,dcts,anyf,status) + call ftgcvd(20,colnum,frow,felem,nrows,nullval,dct,anyf,status) + + if( status /= 0 ) goto 666 + + ! select photometricaly acceptable stars + spot = pi*aper**2 + allocate(id(nrows)) + nid = 0 + do i = 1, nrows +! write(*,'(3f20.3)') ct(i)/(sky(i) * spot) + if( ct(i) > 0 .and. dct(i) > 0 .and. sky(i) > 0 .and. & + ct(i) / (sky(i) * spot) > threshold .and. & + dct(i) / ct(i) < maxerr ) then + nid = nid + 1 + id(nid) = i + end if + end do + + allocate(alpha(nid),delta(nid),cts(nid),dcts(nid)) + do i = 1, nid + j = id(i) + x(i) = x(j) + y(i) = y(j) + cts(i) = ct(j) + dcts(i) = dct(j) + end do + call invtrafo(tproj,x(1:nid),y(1:nid),alpha,delta) + deallocate(x,y,ct,dct,sky) 666 continue @@ -385,17 +415,20 @@ end subroutine checkframe - subroutine readframes(filenames,keys,filters_ref,photosys,ra,dec,cts,dcts,utol,& - exptime,area,filter,tol,init_area,saper,status) + subroutine readframes(filenames,keys,filters_ref,photosys,threshold, & + maxerr,ra,dec,cts,dcts,utol,exptime,area,filter,tol,init_area, & + saper,aper,status) character(len=*), dimension(:), intent(in) :: filenames,keys,filters_ref character(len=*), intent(out) :: photosys + real(dbl), intent(in) :: threshold, maxerr real(dbl), dimension(:,:), allocatable, intent(out) :: ra,dec,cts,dcts real(dbl), dimension(:), allocatable, intent(out) :: exptime,area,tol character(len=FLEN_VALUE), dimension(:), allocatable, intent(out) :: filter real(dbl), intent(in) :: utol integer, intent(in) :: saper logical, intent(in) :: init_area + real(dbl), dimension(:), allocatable, intent(out) :: aper integer, intent(out) :: status real(dbl) :: ftol @@ -439,19 +472,21 @@ ! now, we are prepared to read the data allocate(exptime(nfiles),area(nfiles),tol(nfiles),filter(nfiles), & - cts(nd,nfiles),dcts(nd,nfiles),ra(nd,nfiles),dec(nd,nfiles)) + cts(nd,nfiles),dcts(nd,nfiles),ra(nd,nfiles),dec(nd,nfiles), & + aper(nfiles)) - cts = -1 - dcts = -1 - ra = 0 - dec = 0 + cts = -1.0_dbl + dcts = -1.0_dbl + ra = 0.0_dbl + dec = 0.0_dbl + aper = -1.0_dbl status = 0 do n = 1, nfiles - call readframe(filenames(order(n)),keys,qra,qdec,dn,ddn,ftol,& - exptime(n),area(n),phsys,filter(n),init_area,& - saper,status) + call readframe(filenames(order(n)),keys,threshold,maxerr, & + qra,qdec,dn,ddn,ftol,exptime(n),area(n),phsys,filter(n),& + init_area,saper,aper(n),status) if( status /= 0 ) then write(error_unit,*) "File: `",trim(filenames(n)),"'" @@ -486,6 +521,171 @@ end subroutine readframes + subroutine readref(ref,keys,maxerr,threshold, & + refra,refdec,refph,drefph,filter,exptime, area, aper, status) + + ! + ! WARNING: Only one band is supported ! + ! + use astrotrafo + use phio + + real(dbl), parameter :: rad = 57.295779513082322865_dbl + real(dbl), parameter :: pi = 3.14159 + + character(len=*), intent(in) :: ref + character(len=*), dimension(:), intent(in) :: keys + real(dbl), intent(in) :: maxerr,threshold + real(dbl), dimension(:), allocatable, intent(out) :: refra,refdec + real(dbl), dimension(:,:), allocatable, intent(out) :: refph,drefph + character(len=*), intent(out) :: filter + real(dbl), intent(out) :: exptime, area, aper + integer, intent(in out) :: status + + real(dbl), dimension(:), allocatable :: ra,dec,ph,dph,sky + integer, dimension(:), allocatable :: id + character(len=FLEN_COMMENT) :: com + character(len=FLEN_CARD) :: key + character(len=FLEN_VALUE) :: phkind + integer, parameter :: frow = 1, felem = 1 + real(dbl), parameter :: nullval = 0.0_dbl + real(dbl) :: sep, r, cosd2, scale, spot + logical :: anyf, found + integer :: nrows,nid,rcol,dcol,scol,pcol,ecol,i,j + type(AstroTrafoProj) :: tastr + + if( status /= 0 ) return + + ! open first image extension + call ftiopn(15,ref,0,status) + if( status /= 0 ) goto 666 + + call ftgkys(15,keys(5),filter,com,status) + if( status == KEYWORD_NOT_FOUND ) & + stop 'Filter not found in reference frame.' + + ! WCS + call wcsget(15,tastr,status) + if( status == KEYWORD_NOT_FOUND ) & + stop 'Error: Astrometry keywords not found in header.' + scale = tastr%scale + + call ftgkyd(15,keys(1),exptime,com,status) + if( status == KEYWORD_NOT_FOUND ) then + write(error_unit,*) & + "Warning: Exposure time identified by FITS keyword `", & + trim(keys(1)),"' not found (default to 1 sec)." + exptime = 1 + status = 0 + end if + + call ftgkyd(15,keys(2),area,com,status) + if( status == KEYWORD_NOT_FOUND ) then + ! write(error_unit,*) + !"Warning: Area identified by FITS keyword `",trim(keys(2)), & +! "' not found (default to 1 [m2])." + area = 1 + status = 0 + end if + + ! move to photometry table + call ftmnhd(15,BINARY_TBL,PHOTOEXTNAME,0,status) + if( status == BAD_HDU_NUM ) & + stop 'Failed to find a photometry extension in reference frame.' + + call ftgnrw(15,nrows,status) + + call ftkeyn(FITS_KEY_ANNULUS,1,key,status) + call ftgkyd(15,key,sep,com,status) + + call ftgkys(15,FITS_KEY_PHOTOTYP,phkind,com,status) + if( status == KEYWORD_NOT_FOUND ) & + stop 'PHOTOTYP not found in reference frame.' + + if( phkind == 'APHOT' ) then + ! sep = 2*sep + call ftgkyd(15,FITS_KEY_APER,aper,com,status) + aper = aper / scale + else if( phkind == 'GPHOT' ) then + call ftgkyd(15,FITS_KEY_RF90,aper,com,status) + aper = aper / scale + end if + + call ftgcno(15,.true.,FITS_COL_RA,rcol,status) + call ftgcno(15,.true.,FITS_COL_DEC,dcol,status) + call ftgcno(15,.true.,FITS_COL_SKY,scol,status) + call ftgcno(15,.true.,FITS_COL_PHOTON,pcol,status) + call ftgcno(15,.true.,FITS_COL_PHOTONERR,ecol,status) + if( status /= 0 ) goto 666 + + allocate(ra(nrows),dec(nrows),ph(nrows),dph(nrows),sky(nrows),id(nrows)) + call ftgcvd(15,rcol,frow,felem,nrows,nullval,ra,anyf,status) + call ftgcvd(15,dcol,frow,felem,nrows,nullval,dec,anyf,status) + call ftgcvd(15,scol,frow,felem,nrows,nullval,sky,anyf,status) + call ftgcvd(15,pcol,frow,felem,nrows,nullval,ph,anyf,status) + call ftgcvd(15,ecol,frow,felem,nrows,nullval,dph,anyf,status) + if( status /= 0 ) goto 666 + + ! selection of suitable calibration stars + spot = pi*aper**2 ! sky is per square pixel + + ! selection of isolated stars + nid = 0 + do i = 1, nrows + found = .false. + cosd2 = cos(dec(i) / rad)**2 + do j = 1, nrows + if( i /= j ) then + r = sqrt((ra(i) - ra(j))**2*cosd2 + (dec(i) - dec(j))**2) + if( r < sep ) then + found = .true. + goto 90 + end if + end if + end do +90 continue + + ! accept only those isolated stars with valid measurements ... + if( .not. found .and. ph(i) > 0 .and. dph(i) > 0 .and. & + ! ... and only bright ones above the limit given by sky + ph(i) / (spot*sky(i)) > threshold .and. & + ! ... with the maximum error + dph(i) / ph(i) < maxerr ) then + + nid = nid + 1 + id(nid) = i + + end if + + end do + + if( nid == 0 ) then + write(error_unit,*) & + 'Error: There are no suitable and accurate stars',& + ' on the frame. Try decrease threshold by -th or increase',& + ' the magnitude error by -e.' + stop 'No calibration stars available.' + end if + + allocate(refra(nid),refdec(nid),refph(nid,1),drefph(nid,1)) + do i = 1, nid + r = exptime * area + r = 1.0_dbl + j = id(i) + refra(i) = ra(j) + refdec(i) = dec(j) + refph(i,1) = ph(j) / r + drefph(i,1) = dph(j) / sqrt(r) + end do + +666 continue + + call ftclos(15,status) + call ftrprt('STDERR',status) + + if( allocated(ra) ) deallocate(ra,dec,ph,dph,sky,id) + + end subroutine readref subroutine file_order(filenames,keys,filters_ref,order,maxdat) diff -Nru munipack-0.5.9/photometry/phcal.f95 munipack-0.5.10/photometry/phcal.f95 --- munipack-0.5.9/photometry/phcal.f95 2017-07-17 23:03:48.000000000 +0000 +++ munipack-0.5.10/photometry/phcal.f95 2018-01-16 17:58:04.000000000 +0000 @@ -19,8 +19,9 @@ ! along with Munipack. If not, see . ! ! Problems: -! * calibration frame is not referenced when a frame is referenced to a frame -! * standard deviation has bad value +! * calibration frame is not referenced when a frame is referenced +! to a frame (done) +! * standard deviation has bad value (done) ! ! Adds: ! * Re-design of command line parameters: better defaults to --col-*, @@ -41,19 +42,24 @@ integer, parameter :: dbl = selected_real_kind(15) character(len=4*FLEN_FILENAME) :: line, key, val - character(len=FLEN_FILENAME), dimension(:), allocatable :: filename, backup, newname + character(len=FLEN_FILENAME), dimension(:), allocatable :: filename, backup,& + newname character(len=FLEN_FILENAME) :: ref = '', cat = '', tratable = '', & phsystable = 'photosystems.fits' character(len=FLEN_VALUE), dimension(:), allocatable :: qlabels character(len=FLEN_VALUE) :: col_ra = FITS_COL_RA, col_dec = FITS_COL_DEC, & photsys_ref = '', photsys_instr = '' - character(len=FLEN_VALUE), dimension(:), allocatable :: col_mag, col_magerr, filters + character(len=FLEN_VALUE), dimension(:), allocatable :: col_mag, col_magerr, & + filters logical :: verbose = .false., plog = .false., list = .false. logical :: init_area = .false. , init_photsys = .false. logical :: cal_manual = .false. logical :: advanced = .false. real(dbl) :: utol = -1.0/3600.0 real(dbl) :: area + real(dbl) :: threshold = 0.1 + real(dbl) :: maxerr = 0.01 + real(dbl) :: apcorr = 1.0_dbl real(dbl), dimension(:), allocatable :: ctph_manual,dctph_manual integer :: eq,nfile,n,nmag,nmagerr,nfilters,nctph,saper character(len=FLEN_KEYWORD), dimension(8) :: keys @@ -194,6 +200,18 @@ read(val,*) area init_area = .true. + else if( key == 'THRESHOLD' ) then + + read(val,*) threshold + + else if( key == 'MAXERR' ) then + + read(val,*) maxerr + + else if( key == 'APCORR' ) then + + read(val,*) apcorr + else if( key == 'NQUANTITIES' ) then read(val,*) nqlabels @@ -285,6 +303,9 @@ if( size(filename) == 0 ) stop 'No frames to process.' + if( area <= 0 ) & + stop 'Error: The specified area is negative or zero, very funny!' + if( cat /= '' ) then call calibrate ! catcal ? else if( ref /= '' ) then @@ -319,8 +340,8 @@ character(len=FLEN_VALUE) :: catid,photosys_instr,photsys1,photsys2 character(len=FLEN_VALUE), dimension(:), allocatable :: filter_frames real(dbl), allocatable, dimension(:) :: refra, refdec, ctph,dctph, & - exptime, areas, tol - real(dbl), allocatable, dimension(:,:) :: tr,tr1,trerr,tr1err,refph,drefph, & + exptime, areas, tol, aper + real(dbl), allocatable, dimension(:,:) :: tr,tr1,trerr,tr1err,refph,drefph,& cts,dcts,dn,ddn,ra,dec,mag,dmag real(dbl) :: q type(type_phsys) :: phsyscal @@ -337,8 +358,8 @@ if( nmagerr > 0 .and. nmag /= nmagerr ) & stop 'Magnitude error column(s) does not match magnitudes itself.' - if( nmagerr == 0 ) & - write(error_unit,*) 'Warning: Magnitude error column(s) missing (consider include them).' + if( nmagerr == 0 ) write(error_unit,*) & + 'Warning: Magnitude error column(s) is missing (consider include).' nfiles = size(filename) @@ -352,8 +373,9 @@ call phselect(phsystable,photsys_ref,phsyscal) call phsyspairs(phsyscal,filters,pairs) - call readframes(filename,keys,phsyscal%filter,photosys_instr,ra,dec,dn,ddn, & - utol,exptime,areas,filter_frames,tol,init_area,saper,status) + call readframes(filename,keys,phsyscal%filter,photosys_instr,threshold,& + maxerr,ra,dec,dn,ddn,utol,exptime,areas,filter_frames,tol,init_area,& + saper,aper,status) if( status /= 0 ) stop 'Failed to read frames.' if( size(filter_frames) /= size(filters) ) & stop 'Filters and frames dimensions differs.' @@ -362,19 +384,31 @@ if( verbose ) then write(*,*) 'Filename, filter, exptime [s], area [m2]:' do i = 1,size(filename) - write(*,'(2(a,3x),2(f0.3,1x))') trim(filename(i)),trim(filter_frames(i)), & - exptime(i), areas(i) + write(*,'(2(a,3x),2(f0.3,1x))') trim(filename(i)), & + trim(filter_frames(i)),exptime(i), areas(i) end do end if +! write(*,*) mag +! write(*,*) cts call jamcat(tol, refra, refdec, mag, dmag, ra,dec,dn,ddn,cts,dcts) ncat = size(cts,1) - if( ncat == 0 ) stop 'Joint stars not found.' + if( ncat == 0 ) stop 'Catalogue to frame joint stars not found.' allocate(refph(ncat,size(mag,2)),drefph(ncat,size(mag,2))) if( photsys_ref /= '' ) then - call phsysmagph(phsyscal,filters,pairs,mag(1:ncat,:),dmag(1:ncat,:),refph,drefph) + call phsysmagph(phsyscal,filters,pairs,mag(1:ncat,:),dmag(1:ncat,:), & + refph,drefph) + +! q = 1200*0.3 !25.0 / 36.0 + q = exptime(1)*areas(1) +! q = 1 + where( refph > 0 ) + refph = refph * q +! drefph = sqrt(refph) + drefph = drefph * sqrt(q) + end where else ! undefined photosystem, relative rates call relmagph(mag(1:ncat,:),dmag(1:ncat,:),refph,drefph) @@ -383,7 +417,8 @@ if( tratable/= '' ) then call traload(tratable,photsys2,photsys1,tr,trerr,tr1,tr1err,status) - if( status /= 0 ) stop 'Instrumental to standard conversion table not found.' + if( status /= 0 ) & + stop 'Instrumental to standard conversion table not found.' if( photsys2 /= photsys_ref ) & stop 'Reference photometry system does not match the conversion table.' if( photsys1 /= photsys_instr ) & @@ -409,10 +444,12 @@ do i = 1,size(filters) write(*,'(1x,a,6f8.3)') trim(filters(i)),tr1(i,:) end do +! write(*,*) 'Photon and count rates are in [*/s/m2].' end if do n = 1,nfiles q = exptime(n)*areas(n) + q = 1.0_dbl cts(1:ncat,n) = cts(1:ncat,n) / q dcts(1:ncat,n) = dcts(1:ncat,n) / sqrt(q) end do @@ -425,12 +462,17 @@ enddo if( nfiles == 1 ) then - call calibr(refph,drefph,cts(1:ncat,:),dcts(1:ncat,:),ctph,dctph,phres,verbose) + call calibr(refph,drefph,cts(1:ncat,:),dcts(1:ncat,:),ctph,dctph, & + phres,verbose) else - call caliber(pairs,filters,tr,tr1,refph,drefph,cts(1:ncat,:),dcts(1:ncat,:), & - ctph,dctph,phres,verbose) + call caliber(pairs,filters,tr,tr1,refph,drefph, & + cts(1:ncat,:),dcts(1:ncat,:),ctph,dctph,phres,verbose) end if + ! apperture correction + ctph = apcorr * ctph + dctph = apcorr * dctph + if( verbose ) then if( nfiles > 1 ) then write(*,*) 'Relative residuals:' @@ -457,7 +499,7 @@ if( allocated(pairs) ) deallocate(pairs) call deallocate_phsyscal(phsyscal) - deallocate(refra,refdec,refph,drefph,filter_frames,exptime,areas, & + deallocate(refra,refdec,refph,drefph,filter_frames,exptime,areas,aper, & tol,tr,tr1,trerr,tr1err,cts,dcts,dn,ddn,ra,dec,mag,dmag,ctph,dctph) end subroutine calibrate @@ -487,16 +529,17 @@ use sfits character(len=FLEN_VALUE) :: catid,photosys_frames - character(len=FLEN_VALUE), dimension(:), allocatable :: filter_ref,filters_fram + character(len=FLEN_VALUE), dimension(:), allocatable :: filter_ref, & + filters_fram real(dbl), allocatable, dimension(:) :: refra, refdec, ctph,dctph, & - exptime, areas, tol + exptime, areas, tol, aper real(dbl), allocatable, dimension(:,:) :: refph,drefph, & cts,dcts,ra,dec - real(dbl), dimension(1,1), parameter :: tratab = real(1,dbl) + real(dbl), dimension(1,1), parameter :: tratab = real(1.0,dbl) type(photores), dimension(:), allocatable :: phres type(type_phsys) :: phsyscal - integer :: status,nfiles,ncat,i - real(dbl) :: q + integer :: status,nfiles,ncat,i,n + real(dbl) :: reftime, refarea, refaper, q nfiles = size(filename) status = 0 @@ -507,21 +550,43 @@ ! reference system call phselect(phsystable,photsys_ref,phsyscal) - call readref(ref,refra,refdec,refph,drefph,filter_ref(1),status) + call readref(ref,keys,maxerr,threshold,refra,refdec,refph,drefph, & + filter_ref(1),reftime,refarea,refaper,status) if( status /= 0 ) stop 'Failed to read a reference frame.' catid = trim(ref) - call readframes(filename,keys,phsyscal%filter,photosys_frames,ra,dec,cts,dcts,& - utol,exptime,areas,filters_fram,tol,init_area,saper,status) + call readframes(filename,keys,phsyscal%filter,photosys_frames,threshold,& + maxerr,ra,dec,cts,dcts,utol,exptime,areas,filters_fram,tol,init_area,& + saper,aper,status) if( status /= 0 ) stop 'Failed to read frames.' if( init_area ) areas = area + if( any(abs(refaper - aper) > 0.1) ) & + write(error_unit,*) 'Warning: synthetic apertures looks different.' + + q = (reftime * refarea) / (exptime(1)*areas(1)) +! write(*,*) q,sqrt(q) + refph = refph / q + drefph = drefph / sqrt(q) + + if( verbose ) then + write(*,*) 'Filename, filter, exptime [s], area [m2]:' + write(*,'(2(a,3x),2(f0.3,1x),a)') trim(ref), & + trim(filter_ref(1)),reftime,refarea,' (reference)' + do i = 1,size(filename) + write(*,'(2(a,3x),2(f0.3,1x))') trim(filename(i)), & + trim(filters_fram(i)),exptime(i),areas(i) + end do + end if call jamref(tol, refra, refdec, refph, drefph, ra,dec,cts,dcts) ncat = size(cts,1) + if( ncat == 0 ) stop 'Frame to frame joint stars not found.' do n = 1,nfiles q = exptime(n)*areas(n) + q = 1.0_dbl +! q = (reftime * refarea) / (exptime(n)*areas(n)) cts(1:ncat,n) = cts(1:ncat,n) / q dcts(1:ncat,n) = dcts(1:ncat,n) / sqrt(q) end do @@ -536,11 +601,16 @@ call calibr(refph(1:ncat,:),drefph(1:ncat,:),cts(1:ncat,:),dcts(1:ncat,:),& ctph,dctph,phres,verbose) - call writecal(filename,backup,newname,keys,advanced,phsystable,filters_fram,& - catid,photsys_ref,area,init_area,saper,tratab,ctph,dctph,qlabels,phres) + ! apperture correction + ctph = apcorr * ctph + dctph = apcorr * dctph + + call writecal(filename,backup,newname,keys,advanced,phsystable, & + filters_fram,catid,photsys_ref,area,init_area,saper,tratab, & + ctph,dctph,qlabels,phres) - deallocate(refra,refdec,refph,drefph,filter_ref,filters_fram,exptime,areas, & - tol,cts,dcts,ra,dec,ctph,dctph) + deallocate(refra,refdec,refph,drefph,filter_ref,filters_fram,exptime, & + areas,tol,cts,dcts,ra,dec,ctph,dctph) do i = 1,size(phres) call photores_destroy(phres(i)) @@ -563,7 +633,8 @@ if( tratable/= '' ) then call traload(tratable,photsys2,photsys1,tr,trerr,tr1,tr1err,status) - if( status /= 0 ) stop 'Instrumental to standard conversion table not found.' + if( status /= 0 ) & + stop 'Instrumental to standard conversion table not found.' if( size(tr,1) /= size(filters) ) & stop "Dimensions of transformation table and filters doesn't corresponds." if( photsys2 /= photsys_ref ) & @@ -584,128 +655,11 @@ catid = '' call writecal(filename,backup,newname,keys,advanced,phsystable,filters, & - catid,photsys_ref,area,init_area,saper,tr1,ctph_manual, & - dctph_manual,qlabels) + catid,photsys_ref,area,init_area,saper,tr1,apcorr*ctph_manual, & + apcorr*dctph_manual,qlabels) deallocate(tr,tr1,trerr,tr1err) end subroutine mancal - - subroutine readref(ref,refra,refdec,refph,drefph,filter,status) - - ! - ! WARNING: Only one band is supported ! - ! - - real(dbl), parameter :: rad = 57.295779513082322865_dbl - - character(len=*), intent(in) :: ref - real(dbl), dimension(:), allocatable, intent(out) :: refra,refdec - real(dbl), dimension(:,:), allocatable, intent(out) :: refph,drefph - character(len=*), intent(out) :: filter - integer, intent(in out) :: status - - real(dbl), dimension(:), allocatable :: ra,dec,ph,dph - integer, dimension(:), allocatable :: id - character(len=FLEN_COMMENT) :: com - character(len=FLEN_CARD) :: key - integer, parameter :: frow = 1, felem = 1 - real(dbl), parameter :: nullval = 0 - real(dbl) :: sep, r, cosd2, ctph, dctph, skystd, phrel, phmin - logical :: anyf, found - integer :: nrows,nid,rcol,dcol,pcol,ecol,i,j - - if( status /= 0 ) return - - ! open and move to a table extension - call ftiopn(15,ref,0,status) - - call ftgkys(15,keys(5),filter,com,status) - if( status == KEYWORD_NOT_FOUND ) & - stop 'Filter not found in reference frame. Detected an internal inconsistency.' - - call ftmnhd(15,BINARY_TBL,PHOTOEXTNAME,0,status) - if( status == BAD_HDU_NUM ) & - stop 'Failed to find a photometry extension in reference frame.' - - call ftgnrw(15,nrows,status) - - call ftkeyn(FITS_KEY_ANNULUS,1,key,status) - call ftgkyd(15,key,sep,com,status) - - call ftgkyd(15,FITS_KEY_CTPH,ctph,com,status) - call ftgkyd(15,FITS_KEY_CTPHERR,dctph,com,status) - call ftgkyd(15,FITS_KEY_SKYSTD,skystd,com,status) - - call ftgcno(15,.true.,FITS_COL_RA,rcol,status) - call ftgcno(15,.true.,FITS_COL_DEC,dcol,status) - call ftgcno(15,.true.,FITS_COL_PHOTRATE,pcol,status) - call ftgcno(15,.true.,FITS_COL_PHOTRATEERR,ecol,status) - if( status /= 0 ) goto 666 - - allocate(ra(nrows),dec(nrows),ph(nrows),dph(nrows),id(nrows)) - call ftgcvd(15,rcol,frow,felem,nrows,nullval,ra,anyf,status) - call ftgcvd(15,dcol,frow,felem,nrows,nullval,dec,anyf,status) - call ftgcvd(15,pcol,frow,felem,nrows,nullval,ph,anyf,status) - call ftgcvd(15,ecol,frow,felem,nrows,nullval,dph,anyf,status) - - if( status /= 0 ) goto 666 - - - ! selection of stars suitable as calibration ones - - ! we accept only bright stars under the conditions: - ! * relative precision is better than one for reference - phrel = max(dctph / ctph, 1e-3) - ! * minimal photon rate is larger than sky error within inner aperture - phmin = skystd * 3.14*sep**2 * 3600**2 - -! write(*,*) phrel,phmin - - ! selection of isolated stars - nid = 0 - do i = 1, nrows - found = .false. - cosd2 = cos(dec(i) / rad)**2 - do j = 1, nrows - if( i /= j ) then - r = sqrt((ra(i) - ra(j))**2*cosd2 + (dec(i) - dec(j))**2) - if( r < sep ) then - found = .true. - goto 90 - end if - end if - end do -90 continue - - ! accept only valid measurements ... - if( .not. found .and. ph(i) > 0 .and. dph(i) > 0 ) then - - ! ... and only bright stars, the limit is derived from relative - ! precision of calibration .. and sky error determination - ! if( dph(i) / ph(i) < phrel .and. ph(i) > phmin ) then - if( .true. ) then - nid = nid + 1 - id(nid) = i - end if - end if - end do - - allocate(refra(nid),refdec(nid),refph(nid,1),drefph(nid,1)) - refra = ra(1:nid) - refdec = dec(1:nid) - refph(:,1) = ph(1:nid) - drefph(:,1) = dph(1:nid) - deallocate(ra,dec,ph,dph,id) - -666 continue - - call ftclos(15,status) - call ftrprt('STDERR',status) - - if( allocated(ra) ) deallocate(ra,dec,ph,dph,id) - - end subroutine readref - end program phcal diff -Nru munipack-0.5.9/photometry/sfits.f95 munipack-0.5.10/photometry/sfits.f95 --- munipack-0.5.9/photometry/sfits.f95 2017-07-17 23:03:48.000000000 +0000 +++ munipack-0.5.10/photometry/sfits.f95 2018-01-16 17:58:04.000000000 +0000 @@ -1,7 +1,7 @@ ! ! FITS I/O for photometry calibration ! -! Copyright © 2014-6 F.Hroch (hroch@physics.muni.cz) +! Copyright © 2014-7 F.Hroch (hroch@physics.muni.cz) ! ! This file is part of Munipack. ! @@ -59,6 +59,8 @@ use mfits use colorex + real, parameter :: pi = 3.14159 + character(len=*), dimension(:), intent(in) :: filenames,backups,newnames,keys, & quantities, filters character(len=*), intent(in) :: photsys, catid, phsystable @@ -79,7 +81,7 @@ real(dbl), dimension(:,:), allocatable :: ras,decs,ct,dct,sky,dsky,ph,dph, & phsky,dphsky,mag,dmag,phrate,dphrate real, dimension(:,:,:), allocatable :: cube,tcube - real(dbl), dimension(size(ctph)) :: xctph,sqarcsec,airmass + real(dbl), dimension(size(ctph)) :: xctph,sqarcsec,airmass,aring,nsky real(dbl), dimension(1,size(ctph)) :: skymag,dskymag,skyrate,dskyrate integer, allocatable, dimension(:) :: order integer :: i,j,k,n,status,nrows_max, width, height, nq, ncat, nfiles, nrows, npht @@ -95,7 +97,6 @@ ! init photometry parameters call phselect(phsystable,photsys,phsyscal) call phsyspairs(phsyscal,filters,pairs) - call file_order(filenames,keys,phsyscal%filter,order) nrows_max = 0 @@ -211,8 +212,15 @@ do n = 1,size(fitses) xctph(n) = fitses(n)%area * fitses(n)%exptime sqarcsec(n) = (3600 * fitses(n)%scale)**2 + ! unused: + aring(n) = pi*(fitses(n)%annuls(2)**2 - fitses(n)%annuls(1)**2) / & + fitses(n)%scale**2 + nsky(n) = pi*fitses(n)%aper**2/fitses(n)%scale**2 end do +! write(*,*) aring +! write(*,*) nsky + allocate(mag(ncat,nfiles),dmag(ncat,nfiles),phrate(ncat,nfiles),dphrate(ncat,nfiles)) if( nfiles > 1 ) then @@ -224,23 +232,31 @@ do i = 1,ncat if( nfiles == 1 )then - where( ct(i,:) > 0 ) - ph(i,:) = ctph(1)*ct(i,:) - dph(i,:) = ph(i,:)*(dct(i,:)/ct(i,:)) - elsewhere - ph(i,:) = -1 - dph(i,:) = -1 - end where - where( sky(i,:) > 0 ) - phsky(i,:) = ctph(1)*sky(i,:) +! write(*,*) sqrt(ctph(1)),sqarcsec(1), dsky(i,1) + where( sky(i,:) > 0 .and. dsky(i,:) > 0 ) + phsky(i,:) = ctph(1) * sky(i,:) !* sqarcsec(1) dphsky(i,:) = phsky(i,:) * (dsky(i,:)/sky(i,:)) +! dphsky(i,:) = sqrt(ctph(1)) * dsky(i,:) !* sqarcsec(1) elsewhere phsky(i,:) = -1 dphsky(i,:) = -1 end where + where( ct(i,:) > 0 .and. dct(i,:) > 0 ) + ph(i,:) = ctph(1)*ct(i,:) +! dph(i,:) = ph(i,:)*(dct(i,:)/ct(i,:)) + dph(i,:) = sqrt(ctph(1)) * dct(i,:) + !dph(i,:) = sqrt(ph(i,:) + dphsky(i,:)**2*nsky(1)**2 + & + ! dphsky(i,:)**2*pi*nsky(1)**2) + elsewhere + ph(i,:) = -1 + dph(i,:) = -1 + end where + +! write(*,*) sqrt(abs(ph(i,:))),sqrt(dphsky(i,:)**2*nsky(1)**2), & +! sqrt(dphsky(i,:)**2*pi*nsky(1)**2) else ct(i,:) = ctph * ct(i,:) / xctph - dct(i,:) = ctph * dct(i,:) / xctph + dct(i,:) = ctph * dct(i,:) / xctph !! needs correct !!! sky(i,:) = ctph * sky(i,:) / xctph dsky(i,:) = ctph * dsky(i,:) / xctph call fotra(tra,pairs,ct(i,:),dct(i,:),phrate(i,:),dphrate(i,:)) @@ -248,14 +264,14 @@ call correx(phsyscal%lam_eff,phsyscal%lam_fwhm/2,airmass,k0,r,lref,phrate(i,:)) where( phrate(i,:) > 0 ) ph(i,:) = phrate(i,:) * xctph - dph(i,:) = dphrate(i,:) * xctph + dph(i,:) = dphrate(i,:) * xctph !! correct !!! elsewhere ph(i,:) = - 1 dph(i,:) = -1 end where where( phsky(i,:) > 0 ) phsky(i,:) = phsky(i,:) * xctph - dphsky(i,:) = dphsky(i,:) * xctph + dphsky(i,:) = dphsky(i,:) * xctph !! correct needs!!! elsewhere phsky(i,:) = -1 dphsky(i,:) = -1 @@ -263,18 +279,20 @@ end if end do +! write(*,*) ct(4,1),ph(4,1) do i = 1, nfiles call rmean(phsky(:,i),rsky,rskyerr) - skyrate(1,i) = rsky / xctph(i) / sqarcsec(i) - dskyrate(1,i)= (rskyerr / rsky) * skyrate(1,i) + skyrate(1,i) = (rsky / xctph(i)) / sqarcsec(i) + dskyrate(1,i)= (rskyerr / (xctph(i)) / sqarcsec(i)) end do if( nfiles == 1 ) then - call phsysphmag1(phsyscal,filters(1),ph(:,1)/xctph(1),dph(:,1)/xctph(1),& - mag(:,1),dmag(:,1)) + call phsysphmag1(phsyscal,filters(1),ph(:,1)/xctph(1), & + dph(:,1)/sqrt(xctph(1)),mag(:,1),dmag(:,1)) call phsysphmag1(phsyscal,filters(1),skyrate(1,:),dskyrate(1,:), & skymag(1,:),dskymag(1,:)) +! write(*,*) trim(filenames(1)),xctph(1),ph(4,1),mag(4,1) else call phsysphmag(phsyscal,filters,pairs,phrate,dphrate,mag,dmag) call phsysphmag(phsyscal,filters,pairs,skyrate,dskyrate,skymag,dskymag) @@ -439,7 +457,7 @@ do i = 1, naper call ftkeyn(FITS_KEY_APER,i,key,status) call ftgkye(25,key,aper,buf,status) - if( aper > 3*hwhm ) then + if( aper > 2*hwhm ) then maper = i exit end if diff -Nru munipack-0.5.9/preprocess/flat_debug.sh munipack-0.5.10/preprocess/flat_debug.sh --- munipack-0.5.9/preprocess/flat_debug.sh 1970-01-01 00:00:00.000000000 +0000 +++ munipack-0.5.10/preprocess/flat_debug.sh 2018-01-16 17:58:04.000000000 +0000 @@ -0,0 +1,29 @@ + +# run flat with debug on (recompile required): +# logical, parameter :: debug = .true. +# + +gnuplot <. ! ! -! TODO: -! * add running statistical tests of Normal distribution of residuals (**) -! -Program aFlat +program aflat use LibList use robustmean use weightedmean - use robustline use robratio + use robustflat use medians use fitsio use xfitsio @@ -51,19 +48,18 @@ ! No. of image dimensions integer, parameter :: DIM = 2 - ! Default output mean level: - real :: level = -1 - - ! saturation - real :: saturate_set = -1 + ! lower and upper limits + real :: saturate_set = -1 + real :: threshold_set = 0 integer :: i,j,eq,nobs, istat, naxis,n,l, iter integer, dimension(DIM) :: naxes integer :: bitpix = -32 - integer :: maxiter = 3 + integer :: maxiter = 7 + character(len=8) :: approximation = 'STANDARD' - ! image - real :: avg, sig, t, savg, dt, g, d, egain, sgain, fmean, time, saturate, mindt, maxd + real :: avg, sig, t, savg, dt, g, d, egain, sgain, fmean, time, saturate, & + eflat, waterline, thresh real :: darketime = -1 real :: etime = -1 real :: xdark = -1.0 @@ -71,19 +67,20 @@ logical :: gain_set = .false. logical :: gain_estimate = .false. real, allocatable, dimension(:,:) :: flat,dflat,res,des,bias,dark,ebias,edark - real, allocatable, dimension(:) :: fbuf, dbuf, egains + real, allocatable, dimension(:) :: fbuf, dbuf, abuf, sbuf, egains real, dimension(:,:), pointer :: ccd, err - logical, allocatable, dimension(:,:) :: mask - Character(len=4*FLEN_FILENAME) :: sb,key,val,record,buf,biasname='',darkname='' - Character(len=FLEN_CARD) :: dateobs,f,dateobs1,filter1,imagetyp1,imagetyp,precession - character(len=FLEN_KEYWORD) :: FILTER=FITS_KEY_FILTER,DATE_OBS=FITS_KEY_DATEOBS, & - EXPTIME=FITS_KEY_EXPTIME, KEY_IMAGETYP=FITS_KEY_IMAGETYP, KEY_GAIN=FITS_KEY_GAIN,& + logical, allocatable, dimension(:,:) :: mask, bitmask + character(len=FLEN_FILENAME) :: sb,record,buf,key,val, & + biasname='', darkname='', maskname='' + character(len=FLEN_VALUE) :: dateobs,dateobs1,filter,filter1, & + imagetyp1, imagetyp + character(len=FLEN_KEYWORD) :: KEY_FILTER=FITS_KEY_FILTER, & + DATE_OBS=FITS_KEY_DATEOBS, KEY_EXPTIME=FITS_KEY_EXPTIME, & + KEY_IMAGETYP=FITS_KEY_IMAGETYP, KEY_GAIN=FITS_KEY_GAIN,& KEY_SATURATE=FITS_KEY_SATURATE type(Imagetype), pointer :: list,curr - type(xFITS) :: fits, biasfits, darkfits + type(xFITS) :: fits, biasfits, darkfits, maskfits logical :: reliable, terminate - real(dbl) :: gzero,ggain,dzero,dgain - real(dbl), dimension(:), allocatable :: fmeans, sig2s buf = '' filter1 = '' @@ -91,6 +88,7 @@ call xfits_init(biasfits) call xfits_init(darkfits) + call xfits_init(maskfits) call InitList(list) curr => list @@ -111,33 +109,40 @@ read(val,*) bitpix endif - if( key == 'LEVEL' ) then - read(val,*) level - endif - if( key == 'SATURATE' ) then read(val,*) saturate_set + if( saturate_set <= 0 ) stop 'Only positive saturations are allowed.' + endif + + if( key == 'THRESHOLD' ) then + read(val,*) threshold_set + if( threshold_set <= 0 ) stop 'Only positive thresholds are allowed.' + endif + + if( key == 'GAIN' ) then + read(val,*) gain + gain_set = .true. endif if( key == 'VERBOSE' ) then read(val,*) verbose endif - if( key == 'PRECISION' ) then - read(val,*) precession - if( precession == 'LOW' ) then - maxiter = 2 - else if( precession == 'ZERO' ) then - maxiter = 1 - else if( precession == 'EXTRA' ) then - maxiter = 6 - else + if( key == 'APPROXIMATION' ) then + read(val,*) approximation + if( approximation == 'BASIC' ) then + maxiter = 0 + else !if( approximation == 'STANDARD' ) then maxiter = 3 end if endif + if( key == 'GAIN_ESTIMATE' ) then + read(val,*) gain_estimate + endif + if( key == 'FITS_KEY_FILTER' ) then - read(val,*) FILTER + read(val,*) KEY_FILTER endif if( key == 'FITS_KEY_DATEOBS' ) then @@ -145,7 +150,7 @@ endif if( key == 'FITS_KEY_EXPTIME' ) then - read(val,*) EXPTIME + read(val,*) KEY_EXPTIME endif if( key == 'FITS_KEY_IMAGETYP' ) then @@ -160,10 +165,6 @@ read(val,*) KEY_SATURATE endif - if( key == 'GAIN_ESTIMATE' ) then - read(val,*) gain_estimate - endif - if( key == 'BIAS' ) then read(val,*) biasname @@ -185,7 +186,7 @@ if( .not. darkfits%status ) stop 'Failed to load the dark frame.' istat = 0 - call xfits_kye(darkfits,EXPTIME,darketime,istat) + call xfits_kye(darkfits,KEY_EXPTIME,darketime,istat) if( istat /= 0 ) then istat = 0 darketime = -1 @@ -195,15 +196,20 @@ end if - if( key == 'GAIN' ) then - read(val,*) gain - gain_set = .true. - endif + if( key == 'MASK' ) then + + read(val,*) maskname + if( verbose ) write(error_unit,*) "MASK=",trim(maskname) + call xfits_read(maskname,maskfits) + if( .not. maskfits%status ) stop 'Failed to load the mask frame.' + + end if if( key == 'FILE' ) then if( verbose .and. getno(curr) == 0 ) & - write(error_unit,*) "Filename, exptime[s], gain, saturate[ct], mean, std.err.:" + write(error_unit,*) & + "Filename, exptime[s], gain[ct/adu], saturation[ct], threshold[ct], mean[ct], std.err., reliable:" read(val,*) sb if( verbose ) write(error_unit,'(a)',advance="no") trim(sb)//":" @@ -212,6 +218,7 @@ call xfits_read(sb,fits) if( .not. fits%status ) then call xfits_deallocate(fits) + write(error_unit,*) "Filed to read `",trim(sb),"'. Skipping." goto 665 end if @@ -222,12 +229,12 @@ dateobs = '' end if - call xfits_kys(fits,FILTER,f,istat) + call xfits_kys(fits,KEY_FILTER,filter,istat) if( istat /= 0 ) then istat = 0 - f = '' + filter = '' end if - if( f == '' .and. verbose ) & + if( filter == '' .and. verbose ) & write(error_unit,'(a)',advance="no") "Warning: empty filter .. " call xfits_kys(fits,KEY_IMAGETYP,imagetyp,istat) @@ -236,7 +243,7 @@ imagetyp = '' end if - call xfits_kye(fits,EXPTIME,etime,istat) + call xfits_kye(fits,KEY_EXPTIME,etime,istat) if( istat /= 0 ) then istat = 0 etime = -1 @@ -260,12 +267,13 @@ naxes = fits%naxes dateobs1 = dateobs - filter1 = f + filter1 = filter imagetyp1 = imagetyp if( biasfits%status ) then if( .not. all(biasfits%naxes == naxes) ) then - write(error_unit,*) 'bias:',biasfits%naxes(1),'x',biasfits%naxes(2), & + write(error_unit,*) 'bias:',biasfits%naxes(1),& + 'x',biasfits%naxes(2), & ' current frame:',naxes(1),'x',naxes(2) stop "Bias has incompatible dimensions." end if @@ -273,12 +281,22 @@ if( darkfits%status ) then if( .not. all(darkfits%naxes == naxes) ) then - write(error_unit,*) 'dark:',darkfits%naxes(1),'x',darkfits%naxes(2), & + write(error_unit,*) 'dark:',darkfits%naxes(1), & + 'x',darkfits%naxes(2), & ' current frame:',naxes(1),'x',naxes(2) stop "Dark has incompatible dimensions." end if end if + if( maskfits%status ) then + if( .not. all(maskfits%naxes == naxes) )then + write(error_unit,*) 'bitmask:',maskfits%naxes(1), & + 'x',maskfits%naxes(2), & + ' current frame:',naxes(1),'x',naxes(2) + stop "Mask has incompatible dimensions." + end if + endif + else if( .not. all(naxes == fits%naxes) ) then @@ -287,14 +305,13 @@ goto 665 endif - if( imagetyp1 /= imagetyp ) then - write(error_unit,*) & - "Image-types does not corresponds. Skipping." - goto 665 - endif + if( imagetyp1 /= imagetyp ) & + write(error_unit,'(a)',advance="no") & + "Warning: Image-types does not corresponds. .. current `",& + trim(imagetyp),"'(?)" - if( f /= filter1 ) write(error_unit,'(a)',advance="no") & - "Warning: incompatible filters .. current `",trim(f),"' (?)" + if( filter /= filter1 ) write(error_unit,'(a)',advance="no") & + "Warning: incompatible filters .. current `",trim(filter),"'(?)" endif @@ -311,20 +328,28 @@ if( saturate_set > 0 ) then saturate = saturate_set else - saturate = -1 call xfits_kye(fits,KEY_SATURATE,saturate,istat) if( istat /= 0 ) then istat = 0 - if( fits%bitpix > 0 ) & - saturate = 2.0**fits%bitpix + if( fits%bitpix > 0 ) then + saturate = 2.0**fits%bitpix - 1 + else + saturate = maxval(fits%image)*(1 + epsilon(saturate)) + end if end if - if( saturate < 0 ) & - saturate = maxval(fits%image) + epsilon(saturate) + end if + + ! threshold + if( threshold_set > 0 ) then + thresh = threshold_set + else + thresh = 0 end if allocate(ccd(naxes(1),naxes(2)),err(naxes(1),naxes(2)), & - mask(naxes(1),naxes(2)),bias(naxes(1),naxes(2)),dark(naxes(1),naxes(2)),& - ebias(naxes(1),naxes(2)),edark(naxes(1),naxes(2))) + mask(naxes(1),naxes(2)),bias(naxes(1),naxes(2)), & + dark(naxes(1),naxes(2)),ebias(naxes(1),naxes(2)), & + edark(naxes(1),naxes(2)),bitmask(naxes(1),naxes(2))) if( biasfits%status ) then bias = biasfits%image @@ -340,22 +365,32 @@ dark = 0 edark = 0 end if + if( maskfits%status ) then + bitmask = maskfits%image > 0.5 + else + bitmask = .true. + end if - ! Pre-correct the input flat. + ! Preparatory correct the input flat. ! Standard deviation is set with assumption of Poisson distribution - ! of data. It requires large light fluxes, around half of full range. - mask = 0 < fits%image .and. fits%image < saturate + ! of data. It requires large light fluxes, around half of a full range. + mask = thresh < fits%image .and. fits%image < saturate .and. bitmask where( mask ) ccd = gain*(fits%image - (bias + time*dark)) + elsewhere + ccd = -1 end where saturate = gain * saturate - mask = 0 < ccd .and. ccd < saturate + thresh = gain * thresh + mask = thresh < ccd .and. ccd < saturate .and. mask where( mask ) err = sqrt(ccd + gain**2*(ebias**2 + time**2*edark**2)) + elsewhere + err = -1 end where - ! Important. Pixels out of the mask are undefined... + ! Important. Pixels out of the mask has negative values. - ! the average is computed from less of one million elements + ! the average is computed by one million elements or less n = (naxes(1)*naxes(2)) / 1000000 if( n > 0 ) then l = 0 @@ -367,23 +402,27 @@ end do end if - ! determine mean level of this frame - call rwmean(pack(ccd,mask),pack(err,mask),avg,savg,reliable=reliable) + ! determine mean level of current frame + call rwmean(pack(ccd,mask),pack(err,mask),avg,savg,sig, & + reliable=reliable) if( verbose ) & - write(error_unit,'(2x,1pg0.3,2x,0pf0.2,2x,1pg0.2,2x,1pg0.5,3x,1pg0.3,l2)') & - etime,gain,saturate,avg,savg,reliable - - if( avg <= epsilon(avg) ) then - write(error_unit,*) 'This frame has zero or negative mean level. Skipping.' + write(error_unit, & + '(2x,1pg0.3,2x,0pf0.2,2x,1p,2(g0.2,1x),2x,1pg0.5,3x,1pg0.3,l2)') & + etime,gain,saturate,thresh,avg,sig,reliable + + if( .not. (avg > 0) ) then + write(error_unit,*) & + 'This frame has zero or negative mean level. Skipping.' deallocate(ccd,err) else ! add image to the list - Call AddItem (curr,image=ccd,noise=err,filename=sb,mean=avg,stderr=savg, & - dateobs=dateobs,filter=f,satur=saturate) + Call AddItem (curr,image=ccd,noise=err,filename=sb,mean=avg, & + stderr=savg,stdsig=sig,dateobs=dateobs,filter=filter, & + satur=saturate) end if - deallocate(mask,bias,dark,ebias,edark) + deallocate(mask,bias,dark,ebias,edark,bitmask) 665 continue call xfits_deallocate(fits) @@ -399,74 +438,92 @@ if( verbose ) then write(error_unit,*) write(error_unit,*) 'Number of input images:',nobs - write(error_unit,*) 'Dimension:',naxes(1),'x',naxes(2) + write(error_unit,*) 'Dimensions:',naxes(1),'x',naxes(2) write(error_unit,*) 'Filter: ',trim(filter1) + write(error_unit,*) 'Precision of appoximation: ',trim(approximation) end if - ! compute averadged flat-field + ! Section: flat-field computation by flux calibration allocate(flat(naxes(1),naxes(2)),dflat(naxes(1),naxes(2)),& res(naxes(1),naxes(2)),des(naxes(1),naxes(2)),mask(naxes(1),naxes(2)), & - fbuf(nobs),dbuf(nobs),egains(nobs),fmeans(nobs),sig2s(nobs)) + fbuf(nobs),dbuf(nobs),abuf(nobs),sbuf(nobs),bitmask(naxes(1),naxes(2)),& + egains(nobs)) - terminate = .false. - do iter = 1,5 + if( maskfits%status ) then + bitmask = maskfits%image > 0.5 + else + bitmask = .true. + end if - if( verbose ) write(error_unit,'(a,i0,a)') & - 'Calculating a flat-field frame (iteration #',iter-1,') ...' + ! Initial mean flat + if( verbose ) write(error_unit,'(a)') & + 'Calculating the initial flat-field frame (iter. #0) ...' + do j = 1,naxes(2) + do i = 1,naxes(1) + + ! this is initial estimate only + ! lighter frames has smaller influence due Poisson statistics + curr => list + n = 0 + do + curr => GetNext(curr) + if( .not. associated(curr) ) exit + call GetItem(curr,image=ccd,noise=err,mean=avg,stdsig=sig, & + satur=saturate) + if( thresh < ccd(i,j) .and. ccd(i,j) < saturate .and. & + err(i,j) > 0 .and. bitmask(i,j) .and. avg > 0 ) then + n = n + 1 + fbuf(n) = ccd(i,j) / avg + dbuf(n) = sqrt(err(i,j)**2 / avg**2 + sig**2) + end if + enddo + if( n > 0 ) then + call rwmean(fbuf(1:n),dbuf(1:n),flat(i,j),dflat(i,j), & + reliable=reliable) + if( .not. reliable ) & + call rmean(fbuf(1:n),flat(i,j),dflat(i,j)) + else + flat(i,j) = 1 + dflat(i,j) = 0 + end if - ! mean flat - do j = 1,naxes(2) - do i = 1,naxes(1) + enddo + enddo - curr => list - n = 0 - do - curr => GetNext(curr) - if( .not. associated(curr) ) exit - call GetItem(curr,image=ccd,noise=err,mean=avg,satur=saturate) - if( 0 < ccd(i,j) .and. ccd(i,j) < saturate ) then - n = n + 1 - fbuf(n) = ccd(i,j) / avg - dbuf(n) = err(i,j) / avg - end if - enddo - if( n > 0 ) then - call rwmean(fbuf(1:n),dbuf(1:n),flat(i,j),dflat(i,j),reliable=reliable) + if( debug ) then + ! write out the first estimate -!!$ if( .not. reliable .and. .false. ) then -!!$! if( all( abs(fbuf(1:n) - 1) < 0.1 ) ) & -!!$ if( dflat(i,j) < 0 ) & -!!$ write(*,*) i,j,fbuf(1:n),dbuf(1:n),flat(i,j),dflat(i,j),n -!!$ call rmean(fbuf(1:n),flat(i,j),dflat(i,j),reliable=reliable) -!!$ if( .not. reliable .and. debug ) then -!!$ write(*,*) 'rmean:',i,j,flat(i,j),dflat(i,j),fbuf(1:n),n -!!$ end if -!!$ end if - -! else if( n == 1 ) then -! flat(i,j) = fbuf(1) -! dflat(i,j) = dbuf(1) ! or 1? - else - flat(i,j) = 1 - dflat(i,j) = 1 + mask = bitmask + where( mask ) + des = sqrt(err**2 + dflat**2) + res = (flat - 1) / des + end where + + open(1,file='/tmp/flatdebug_zero.dat') + do i = 1,size(flat,1),2 + do j = 1,size(flat,2),2 + if( mask(i,j) .and. abs(res(i,j)) < 5 ) then + write(1,*) flat(i,j)-1,res(i,j), flat(i,j) end if + end do + end do + close(1) - enddo - enddo + end if + + terminate = .false. + do iter = 1, maxiter - ! Improving precision of approximation. Thanks to very good initial estimate - ! (and considering slow computations), we are plan to proceed a few -- only one - ! -- iteration(s). The convergence of iterations is fast, the limit - ! of std. deviation of mean is reached immediately after one cycle. - ! The number of iteration is controled by terminate variable which - ! tests whatever maximum of residual is small than expected error or not. + ! Now, we're Improving precision of approximation. The number of + ! iterations is controled by `terminate' variable which tests + ! convergence of subsequent estimates of the created flat. - if( iter == maxiter .or. terminate ) exit + if( terminate ) exit if( verbose ) then write(error_unit,'(a)') 'Scaling individual frames by the flat ...' write(error_unit,'(a)',advance="no") & - "Filename, mean ratio, std.err., correction, reliable" + "Filename, mean level[ct], std.err., reliable" if( gain_estimate ) then write(error_unit,'(a)') ", std.dev., gain:" else @@ -474,109 +531,183 @@ end if end if - ! mindt is minimum of standard errors, while maxd is the maximal residual - mindt = huge(mindt) - maxd = 0 - - ! Update mean of every frame + ! Update means for individual frames curr => list do ! over frames curr => GetNext(curr) if( .not. associated(curr) ) exit - call GetItem(curr,filename=sb,image=ccd,noise=err,mean=avg,stderr=savg,& + call GetItem(curr,filename=sb,image=ccd,noise=err,mean=avg, & satur=saturate) - mask = 0 < ccd .and. ccd < saturate .and. flat > 0 .and. dflat > 0 - call rcal(pack(ccd,mask),pack(err,mask),pack(flat,mask),pack(dflat,mask),t,dt,& - xreliable=reliable,xverb=.false.) - - if( reliable ) then - d = t - avg - avg = t - if( dt < mindt ) mindt = dt - if( abs(d) > maxd ) maxd = abs(d) - end if + mask = thresh < ccd .and. ccd < saturate .and. err > 0 & + .and. flat > 0 .and. dflat > 0 .and. bitmask + call rcal(pack(ccd,mask),pack(err,mask),pack(flat,mask), & + pack(dflat,mask),t,dt,xreliable=reliable,xverb=.false.) + ! We assumes Poisson distribution of flat pixels, their dispersion + ! is bound to the mean value. Data with strong fluence of + ! non-Poisson noise component should be avoided already. if( verbose ) then - write(error_unit,'(a,2x,1pg13.7,1pg11.2,2x,1pg10.2,l3)',advance="no") & - trim(sb)//": ", avg,dt,d,reliable - !Xi2 + write(error_unit, & + '(a,2x,1pg0.5,2x,1pg0.3,2x,l1)',advance="no") & + trim(sb)//": ",t,dt,reliable ! gain estimate if( gain_estimate ) then call rmean(pack(ccd/flat, mask),fmean,savg,sig) g = fmean / sig**2 - write(error_unit,'(1x,f11.3,2x,f6.3)') sig,g -! write(error_unit,'(1x,f11.3,2x,g11.3)') sig,fmean + write(error_unit,'(1x,1pg0.5,2x,0pf0.3)') sig,g egains(curr%i) = g - fmeans(curr%i) = fmean - sig2s(curr%i) = sig**2 + + ! The value of fmean is principally identical to t by rcal. + ! The rmean is convenience way how to determine variance + ! (rcal uses regularisation which gives var ~ 1 in any case). else write(error_unit,*) end if - if( debug ) then - ! (**) - ! Diagnostics. The second column of the files - ! are residuals intended for Normality testing. - - where( mask ) - des = sqrt(err**2 + t**2*dflat**2) - res = (ccd - t*flat) / des - end where - - open(1,file='/tmp/'//trim(sb)//'.dat') - write(1,'(2a)') '# ',sb - do i = 1,size(ccd,1),2 - do j = 1,size(ccd,2),2 - if( mask(i,j) .and. abs(res(i,j)) < 5 ) then - write(1,*) ccd(i,j)-t,res(i,j), flat(i,j) - end if - end do - end do - close(1) - end if end if - call SetItem(curr,mean=avg) + ! update only when our estimate is realiable + if( reliable ) & + call SetItem(curr,mean=t) + + enddo ! over all frames + + ! update flat + if( verbose ) write(error_unit,'(a,i0,a)') & + 'Calculating a flat-field frame (iter. #',iter,') ...' + res = -1 + do j = 1,naxes(2) + do i = 1,naxes(1) + + curr => list + n = 0 + do + curr => GetNext(curr) + if( .not. associated(curr) ) exit + call GetItem(curr,image=ccd,noise=err,mean=avg,stdsig=sig,& + satur=saturate) + if( thresh < ccd(i,j) .and. ccd(i,j) < saturate .and. & + err(i,j) > 0 .and. bitmask(i,j) .and. & + avg > 0 .and. sig > 0 ) then + n = n + 1 + fbuf(n) = ccd(i,j) + dbuf(n) = err(i,j) + abuf(n) = avg + sbuf(n) = sig + end if + enddo + if( n > 0 ) then + + avg = flat(i,j) + + if( debug .and. i == naxes(1)/2 .and. j == naxes(2)/2 ) & + call rflat(fbuf(1:n),dbuf(1:n),abuf(1:n),sbuf(1:n), & + flat(i,j),dflat(i,j),reliable,verbose=.true.) + + call rflat(fbuf(1:n),dbuf(1:n),abuf(1:n),sbuf(1:n), & + flat(i,j),dflat(i,j),reliable,verbose=.false.) + + ! Non reliable pixels are silently ignored. The data + ! has strongly non-gaussian distribution: the case of + ! bad columns and pixels, an overscan data and etc. + ! if( .not. reliable .and. verbose ) write(*,*) i,j + + ! the absolute difference between the result of previous + ! computation and the current one controls termination + if( reliable ) res(i,j) = abs(avg - flat(i,j)) + + else + flat(i,j) = 1 + dflat(i,j) = 0 + end if - enddo ! over frames + enddo + enddo - terminate = maxd < mindt / sqrt(real(nobs)) + ! terminate condition: the mean difference between two latest + ! subsequent iterations is under the mean std.err. limit + d = median(pack(res,res>0)) + eflat = median(pack(dflat,dflat>0)) + terminate = d < eflat + if( verbose ) & + write(error_unit,'(a,3x,1p,2(g0.1,2x),l1)') & + 'Mean residual and std.dev., terminate:',d,eflat,terminate end do ! iter - ! final mean over the whole area - call rmean(pack(flat,.true.),avg,savg,sig) + if( debug ) then + ! (**) + ! Diagnostics. The second column of the files + ! are residuals intended for Normality testing. + ! + ! https://stackoverflow.com/questions/2471884/ + ! or: + ! gnuplot> binwidth=0.05 + ! gnuplot> bin(x,width)=width*floor(x/width) + ! gnuplot> plot '/tmp/flatdebug_666.fits.dat' \ + ! using (bin($2,binwidth)):(1.0) smooth freq with boxes - ! scale to required level - if( level > 0 ) then - flat = level*flat - dflat = level*dflat - avg = level - savg = level*savg - sig = level*sig - end if + curr => list + do ! over frames + curr => GetNext(curr) + if( .not. associated(curr) ) exit + call GetItem(curr,filename=sb,image=ccd,noise=err,mean=avg, & + satur=saturate) + + mask = thresh < ccd .and. ccd < saturate .and. & + flat > 0 .and. dflat > 0 .and. bitmask + where( mask ) + des = sqrt(err**2 + avg**2*dflat**2) + res = (ccd - avg*flat) / des + end where + + write(buf,'(a,i0,a)') '/tmp/flatdebug_',GetNo(curr),'.dat' + open(1,file=buf) + write(1,'(2a)') '# ',trim(sb) + do i = 1,size(ccd,1),2 + do j = 1,size(ccd,2),2 + if( mask(i,j) .and. abs(res(i,j)) < 5 ) then + write(1,*) ccd(i,j)-avg,res(i,j), flat(i,j) + end if + end do + end do + close(1) + end do + + end if ! debug + + ! final mean over the whole area + call rmean(pack(flat,bitmask),avg,savg,sig) if( gain_estimate ) then call rmean(egains,egain,sgain,t) - call rline(sig2s,fmeans,gzero,ggain,dzero,dgain) -! egain = real(ggain) -! sgain = real(dgain) -! write(*,*) a,b,da,db + end if + + ! integer representation of flat is not recommended in any case, + ! but it can be useful for a compatibility + if( bitpix > 0 ) then + waterline = nint(10.0**(int(log10(2.0**(bitpix-1))))) + ! waterline updates mean levels on 1e2,1e4 and 1e9 + avg = waterline * avg + flat = waterline * flat + dflat = waterline * dflat + if( verbose ) write(error_unit,*) & + 'Warning: Numerical precision degraded by conversion to integers.' end if if( verbose ) then + eflat = median(pack(dflat,dflat>0)) write(error_unit,'(2a)') ' Output image: ',trim(nameflat) write(error_unit,'(a,3x,1pg0.7)') ' Final mean:',avg - write(error_unit,'(a,3x,1pg0.2)') & - ' Expected photometry standard error per pixel:',median(pack(dflat,.true.)) + write(error_unit,'(a,3x,1pg0.1)') & + ' Expected photometry standard error per pixel:',eflat if( gain_estimate ) then - write(error_unit,'(a,2(2x,f0.3))') ' Estimated gain, std.dev:',egain,sgain - if( abs(gain - 1) > epsilon(gain) ) & - write(error_unit,'(a,f0.1,a)') ' Warning! Gain pre-set on: ',gain, & - ' (Consider re-run with -gain 1).' + write(error_unit,'(a,2(2x,f0.3),a,f0.3,a)') & + ' Estimated relative gain, std.err:',egain,sgain, & + ' (original gain was ',gain,').' end if end if @@ -585,14 +716,13 @@ call fitsbackup(nameflat,backup,istat) call ftinit(26,nameflat,1,istat) call ftphps(26,bitpix,naxis,naxes,istat) - call ftpkye(26,'MEAN',avg,6,'Mean level',istat) - call ftpkye(26,KEY_GAIN,gain,6,'[e-/ADU] gain',istat) if( gain_estimate ) then - call ftpkye(26,'GAIN_AVG',egain,6,'[e-/ADU] estimated gain',istat) - call ftpkye(26,'GAIN_STD',sgain,2,'[e-/ADU] std.dev of estimated gain',istat) + call ftpkye(26,'GAIN_AVG',egain,6,'[ct/ADU] estimated gain',istat) + call ftpkye(26,'GAIN_STD',sgain,2,'[ct/ADU] std.dev of estimated gain',& + istat) end if if( filter1 /= '' ) & - call ftpkys(26,FILTER,filter1,'filter of the first on input',istat) + call ftpkys(26,KEY_FILTER,filter1,'filter',istat) if( imagetyp1 /= '' ) & call ftpkys(26,KEY_IMAGETYP,imagetyp,'image type',istat) call ftpkys(26,DATE_OBS,dateobs1,'UTC of the first on input',istat) @@ -602,54 +732,67 @@ endif if( nobs > 0 ) then - write(buf,'(a,i0,a)') 'Result of robust average and scaling of ',nobs,' exposure(s).' + write(buf,'(a,i0,a)') 'Result of robust flat-fielding of ',nobs,& + ' exposure(s).' call ftpcom(26,buf,istat) - call ftpcom(26,'File name, time of start, average, std.err. for each image used:',istat) + call ftpcom(26,& + 'Filename, time of start, mean level[ct] for each image used:',& + istat) curr => list do curr => GetNext(curr) if( .not. associated(curr) ) exit - call GetItem(curr,filename=sb,dateobs=dateobs,mean=avg,stderr=savg) - write(f,'(1pg0.3,1x,1pg0.3)') avg,savg - call ftpcom(26,"'"//trim(sb)//"' '"//trim(dateobs)//"' "//trim(f),istat) + call GetItem(curr,filename=sb,dateobs=dateobs,mean=t) + write(buf,'(1pg0.5)') t + call ftpcom(26,"'"//trim(sb)//"' '"//trim(dateobs)//"' "//trim(buf), & + istat) enddo - call ftpcom(26,'All data are derived from '//trim(DATE_OBS)//' and '//trim(FILTER)//' keywords.',istat) endif + write(buf,'(f0.3)') gain + call ftphis(26,afid//" gain: "//trim(buf),istat) + if( darkname /= '' ) then write(buf,'(f0.5)') time call ftphis(26,afid//" dark: '"//trim(darkname)//"' *"//trim(buf),istat) end if - if( biasname /= '' ) then + if( biasname /= '' ) & call ftphis(26,afid//" bias: '"//trim(biasname)//"'",istat) - end if + + if( maskname /= '' ) & + call ftphis(26,afid//" bitmask: '"//trim(maskname)//"'",istat) + + write(buf,*) thresh + call ftphis(26,afid//" threshold: "//trim(buf)//" [ct] (gain applied)",istat) + + write(buf,*) saturate + call ftphis(26,afid//" saturation: "//trim(buf)//" [ct] (gain applied)",istat) + + write(buf,*) avg + call ftphis(26,afid//" mean level: "//trim(buf)//" [ct]",istat) call ftukys(26,FITS_KEY_CREATOR,FITS_VALUE_CREATOR,FITS_COM_CREATOR,istat) call ftpcom(26,MUNIPACK_VERSION,istat) - ! flat + ! flat-field generated call ftp2de(26,1,naxes(1),naxes(1),naxes(2),flat,istat) - if( istat == NUMERICAL_OVERFLOW ) then - write(error_unit,*) 'Warning: Numerical overflow occurred while writing flat.' - istat = 0 - end if ! standard error of mean call ftiimg(26,bitpix,naxis,naxes,istat) call ftukys(26,'EXTNAME',EXT_STDERR,'',istat) - call ftpcom(26,'The estimation of standard error of mean of pixels of flat-field.',istat) + call ftpcom(26,& + 'The estimation of standard error of mean of pixels of flat-field.',& + istat) call ftp2de(26,1,naxes(1),naxes(1),naxes(2),dflat,istat) - if( istat == NUMERICAL_OVERFLOW ) then - write(error_unit,*) 'Warning: Numerical overflow occurred while writing std.err.' - istat = 0 - end if call ftclos(26,istat) call ftrprt('STDERR',istat) - if( allocated(flat) ) deallocate(flat,dflat,res,des,mask,fbuf,dbuf,egains,fmeans,sig2s) + if( allocated(flat) ) & + deallocate(flat,dflat,res,des,mask,fbuf,dbuf,abuf,sbuf,egains,bitmask) call DestroyList(list) + call xfits_deallocate(maskfits) call xfits_deallocate(biasfits) call xfits_deallocate(darkfits) @@ -659,4 +802,4 @@ stop 'Failed on FITS I/O error.' end if -end Program AFlat +end program aflat diff -Nru munipack-0.5.9/preprocess/Makefile.am munipack-0.5.10/preprocess/Makefile.am --- munipack-0.5.9/preprocess/Makefile.am 2017-07-17 23:03:48.000000000 +0000 +++ munipack-0.5.10/preprocess/Makefile.am 2018-01-16 17:58:04.000000000 +0000 @@ -7,7 +7,7 @@ dark_LDFLAGS = @LIBGFORTRAN@ @LIBGCC@ -L$(top_srcdir)/lib @LDMINPACK@ dark_LDADD = -lmunipack -lstat -lrstat -lfmm -llmin -lsort -lminpacks -lminpack -lfitsio -lcfitsio -lm -flat_SOURCES = xfitsio.f95 flat.f95 +flat_SOURCES = xfitsio.f95 rflat.f08 flat.f95 flat_LDFLAGS = @LIBGFORTRAN@ @LIBGCC@ -L$(top_srcdir)/lib @LDMINPACK@ flat_LDADD = -lmunipack -lstat -lrstat -llmin -lsort -lminpacks -lminpack -lfmm -lcfitsio -lfitsio -lm diff -Nru munipack-0.5.9/preprocess/Makefile.in munipack-0.5.10/preprocess/Makefile.in --- munipack-0.5.9/preprocess/Makefile.in 2017-07-17 23:04:25.000000000 +0000 +++ munipack-0.5.10/preprocess/Makefile.in 2018-01-16 17:58:15.000000000 +0000 @@ -105,7 +105,7 @@ dark_DEPENDENCIES = dark_LINK = $(FCLD) $(AM_FCFLAGS) $(FCFLAGS) $(dark_LDFLAGS) \ $(LDFLAGS) -o $@ -am_flat_OBJECTS = xfitsio.$(OBJEXT) flat.$(OBJEXT) +am_flat_OBJECTS = xfitsio.$(OBJEXT) rflat.$(OBJEXT) flat.$(OBJEXT) flat_OBJECTS = $(am_flat_OBJECTS) flat_DEPENDENCIES = flat_LINK = $(FCLD) $(AM_FCFLAGS) $(FCFLAGS) $(flat_LDFLAGS) \ @@ -277,7 +277,6 @@ builddir = @builddir@ datadir = @datadir@ datarootdir = @datarootdir@ -develop = @develop@ docdir = @docdir@ dvidir = @dvidir@ exec_prefix = @exec_prefix@ @@ -310,7 +309,7 @@ dark_SOURCES = xfitsio.f95 dark.f95 dark_LDFLAGS = @LIBGFORTRAN@ @LIBGCC@ -L$(top_srcdir)/lib @LDMINPACK@ dark_LDADD = -lmunipack -lstat -lrstat -lfmm -llmin -lsort -lminpacks -lminpack -lfitsio -lcfitsio -lm -flat_SOURCES = xfitsio.f95 flat.f95 +flat_SOURCES = xfitsio.f95 rflat.f08 flat.f95 flat_LDFLAGS = @LIBGFORTRAN@ @LIBGCC@ -L$(top_srcdir)/lib @LDMINPACK@ flat_LDADD = -lmunipack -lstat -lrstat -llmin -lsort -lminpacks -lminpack -lfmm -lcfitsio -lfitsio -lm phcorr_SOURCES = xfitsio.f95 phcorr.f95 @@ -319,7 +318,7 @@ all: all-am .SUFFIXES: -.SUFFIXES: .f95 .o .obj +.SUFFIXES: .f08 .f95 .o .obj $(srcdir)/Makefile.in: $(srcdir)/Makefile.am $(am__configure_deps) @for dep in $?; do \ case '$(am__configure_deps)' in \ @@ -410,6 +409,12 @@ distclean-compile: -rm -f *.tab.c +.f08.o: + $(AM_V_FC)$(FCCOMPILE) -c -o $@ $< + +.f08.obj: + $(AM_V_FC)$(FCCOMPILE) -c -o $@ `$(CYGPATH_W) '$<'` + .f95.o: $(AM_V_FC)$(FCCOMPILE) -c -o $@ $< diff -Nru munipack-0.5.9/preprocess/phcorr.f95 munipack-0.5.10/preprocess/phcorr.f95 --- munipack-0.5.9/preprocess/phcorr.f95 2017-07-17 23:03:48.000000000 +0000 +++ munipack-0.5.10/preprocess/phcorr.f95 2018-01-16 17:58:04.000000000 +0000 @@ -160,20 +160,24 @@ if( istat /= 0 ) then istat = 0 flatfilter = '' - if( verbose ) write(error_unit,*) "Warning: a photometric filter of flat-field unknown." + if( verbose ) & + write(error_unit,*) & + "Warning: a photometric filter of flat-field unknown." end if - if( normalise ) then + if( normalise .or. flatfits%bitpix > 0 ) then ! average of flat - call rwmean(pack(flatfits%image,.true.),pack(flatfits%stderr,.true.), & - flatmean,xerr) + call rwmean(pack(flatfits%image, flatfits%stderr > 0),& + pack(flatfits%stderr,flatfits%stderr > 0),flatmean,xerr) if( verbose ) & - write(error_unit,*) 'Flat-frame statistics: mean=',flatmean,'+-',xerr + write(error_unit,*) 'Flat-frame statistics: mean=', & + flatmean,'+-',xerr - if( flatmean < epsilon(flatmean) ) stop 'Mean of flat is not positive.' + if( flatmean < epsilon(flatmean) ) & + stop 'Mean of flat is not positive.' end if @@ -200,14 +204,16 @@ if( istat /= 0 ) then istat = 0 darketime = -1 - if( verbose ) write(error_unit,*) "An exposure time for dark frame unknown." + if( verbose ) & + write(error_unit,*) "An exposure time for dark frame unknown." end if call xfits_kye(darkfits,TEMPERAT,darktemp,istat) if( istat /= 0 ) then istat = 0 darktemp = -999 - if( verbose ) write(error_unit,*) "A temperature for dark frame unknown." + if( verbose ) & + write(error_unit,*) "A temperature for dark frame unknown." end if end if @@ -237,7 +243,8 @@ call xfits_init(fits) call xfits_read(sciname,fits) if( .not. fits%status ) then - write(error_unit,*) "Warning: Failed to read `",trim(sciname),"'. Skippy." + write(error_unit,*) & + "Warning: Failed to read `",trim(sciname),"'. Skippy." call xfits_deallocate(fits) goto 665 end if @@ -290,8 +297,8 @@ if( phalready .and. .not. force_apply ) then write(error_unit,*) & - "Warning: Photometric corrections already applied. Skipping: `", & - trim(sciname),"'" + "Warning: Photometric corrections already applied.", & + " Skipping: `",trim(sciname),"'" goto 665 end if @@ -310,7 +317,8 @@ if( flatfits%status ) then if( .not. all(flatfits%naxes == fits%naxes) )then write(error_unit,*) & - "Warning: Flat-field size does not match corrected frame. Skipping." + "Warning: Flat-field size does not match corrected frame.",& + "Skipped." goto 665 end if @@ -352,7 +360,8 @@ if( verbose .and. darktemp > -273.0 .and. temp > -273.0 )then if( abs(temp - darktemp) > tol_temperat ) & - write(error_unit,*) "Warning: Temperature diference over limit." + write(error_unit,*) & + "Warning: Temperature diference over limit." end if if( xdark > 0.0 ) then @@ -393,7 +402,8 @@ trim(darktext)//trim(biastext)//') '//trim(flattext)//' =' end if - allocate(OUT(fits%naxes(1),fits%naxes(2)),DOUT(fits%naxes(1),fits%naxes(2))) + allocate(OUT(fits%naxes(1),fits%naxes(2)), & + DOUT(fits%naxes(1),fits%naxes(2))) ! the corrections, we are sure that FLAT > 0 where( FLAT > 0 ) @@ -410,7 +420,8 @@ DOUT = 1 end where ! YES, this small piece of code is the full correction!!! - ! All everything is just a practise in reading and writing of FITS files. + ! All everything is just a practise in reading and writing + ! of FITS files. ! convert saturation to electrons if( gain_apply .and. gain_set .and. saturate_set ) & @@ -426,7 +437,8 @@ ! median of the image call rmean(pack(OUT,OUT>0),xmask,xerr) if( verbose ) & - write(error_unit,*) 'Mask frame statistics: mean=',xmask,'+-',xerr + write(error_unit,*) 'Mask frame statistics: mean=',& + xmask,'+-',xerr else ! if( tmask == "ZERO" ) then xmask = 0 xerr = 0 diff -Nru munipack-0.5.9/preprocess/rflat.f08 munipack-0.5.10/preprocess/rflat.f08 --- munipack-0.5.9/preprocess/rflat.f08 1970-01-01 00:00:00.000000000 +0000 +++ munipack-0.5.10/preprocess/rflat.f08 2018-01-16 17:58:04.000000000 +0000 @@ -0,0 +1,304 @@ +! +! Robust Flat Average of normalised flat-fields +! Copyright (C) 2017 Filip Hroch, Masaryk University, Brno, CZ +! +! This file is part of Munipack. +! +! Munipack is free software: you can redistribute it and/or modify +! it under the terms of the GNU General Public License as published by +! the Free Software Foundation, either version 3 of the License, or +! (at your option) any later version. +! +! Munipack is distributed in the hope that it will be useful, +! but WITHOUT ANY WARRANTY; without even the implied warranty of +! MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the +! GNU General Public License for more details. +! +! You should have received a copy of the GNU General Public License +! along with Munipack. If not, see . +! +! + +module robustflat + + use iso_fortran_env + + implicit none + + logical, private :: verb = .false. + + integer, parameter, private :: dbl = selected_real_kind(15) + + real(dbl), dimension(:), allocatable, private :: flat, dflat, cf, dcf, rat + real(dbl), private :: reg, sigma, df, rmin, rmax + + private :: residuals, fmean, zfun, fscale + +contains + + subroutine rflat(flats,dflats,factors,dfactors,fin,dfin,reliable,verbose) + + use medians + + real, dimension(:), intent(in) :: flats,dflats,factors,dfactors + real, intent(in out) :: fin, dfin + logical, intent(out) :: reliable + logical, intent(in), optional :: verbose + + real(dbl) :: f,sigold,regold,sig,fold + integer :: n,i + logical :: freli,sreli,convergent + + if( present(verbose) ) then + verb = verbose + else + verb = .false. + end if + + n = size(flats) + + if( n == 0 ) then + fin = 1 + dfin = 0 + reliable = .false. + return + end if + + if( n <= 2 ) then + fin = sum(flats / factors) / n + dfin = sum(abs(flats / factors - fin)) / n + reliable = .false. + return + end if + + ! Now, we works with appropriate amount of data: n > 2 + allocate(flat(n),dflat(n),cf(n),dcf(n),rat(n)) + flat = flats + dflat = dflats + cf = factors + dcf = dfactors + f = fin + df = dfin + + rat = flat / cf + rmin = minval(rat) + rmax = maxval(rat) + + ! initial estimate of parameters + call finit(f,sig) + if( verb ) & + write(error_unit,'(a,f0.5,1x,f0.3)') 'rflat initial f,sig: ',f,sig + fold = f + + ! avoid other computations on identical data, or + ! low amount of data for robust estimation + if( abs(sig) < 2*epsilon(sig) ) then + fin = real(f) + dfin = 0 + reliable = .true. + goto 666 + end if + + sigold = -1 + do i = 0,666 + reg = i + call fmean(f,sig,freli) + call fscale(f,sig,sreli) + if( verb ) write(error_unit,'(a,f12.7,2(1x,f0.3),2x,2l)') & + ' zmean,sig,reg:',f,sig,reg,freli,sreli + reliable = freli .and. sreli + if( sig < 1 ) exit + sigold = sig + regold = reg + end do + ! solve reg. parameter by linear interpolation to the condition sig=1 + if( sigold > 0 .and. abs(sig - sigold) > epsilon(sig) ) then + reg = regold + (1 - sigold)*(reg - regold)/(sig - sigold) + call fmean(f,sig,reliable) + end if + if( verb ) write(error_unit,'(a,f12.7,2(1x,f0.3),2x,l)') & + 'final zmean,sig,reg:',f,sig,reg,reliable + + if( reliable ) then + ! Newton's update + call fnewton(f,df,sig,convergent) + if( verb ) write(error_unit,'(a,2f13.7,2x,l)') 'Newton:',f,df,convergent + else + fin = real(fold) + end if + + if( convergent .and. reliable ) then + fin = real(f) + dfin = real(df) + end if + +666 continue + deallocate(flat,dflat,cf,dcf,rat) + + end subroutine rflat + + subroutine residuals(f,res,sig) + + real(dbl), intent(in) :: f + real(dbl), dimension(:), intent(out) :: res,sig + + res = flat - cf*f + sig = sqrt(dflat**2 + dcf**2 + flat*reg**2) + + end subroutine residuals + + + subroutine fmean(f,sig,reli) + + use fmm + use medians + + ! This is a robust estimation of the flat. + + real(dbl), intent(in out) :: f + real(dbl), intent(in) :: sig + logical, intent(out) :: reli + real(dbl) :: htol,h,d,gmin,gmax + + sigma = sig + h = 3.3 * median(abs(rat - f)) / 0.6745 + gmin = max(f - h, rmin) + gmax = min(f + h, rmax) + htol = max(1e-6,1e-5*h) +! if( verb ) write(error_unit,*) f,gmin,gmax,h,htol,log((gmax-gmin)/htol) + + f = zeroin(gmin,gmax,zfun,htol) + + d = 2*htol + reli = gmin + d < f .and. f < gmax - d + + ! the realiable result is inside interval rmin .. rmax + ! and not too close to the interval endpoints + + end subroutine fmean + + + function zfun(f) + + use rfun + + real(dbl), intent(in) :: f + real(dbl) :: zfun + real(dbl), dimension(:), allocatable :: psi,res,sig + integer :: n + + n = size(flat) + allocate(psi(n),res(n),sig(n)) + call residuals(f,res,sig) + call tukeys(res/(sigma*sig),psi) + + zfun = -sum(psi*cf/sig) + + deallocate(psi,res,sig) + + end function zfun + + subroutine fscale(f,s,reli) + + use entropyscale + + real(dbl), intent(in) :: f + real(dbl), intent(in out) :: s + logical, intent(out) :: reli + real(dbl), dimension(:), allocatable :: res,sig + integer :: n + + n = size(flat) + allocate(res(n),sig(n)) + call residuals(f,res,sig) + call escale(res/sig,s,reli) + deallocate(res,sig) + + end subroutine fscale + + subroutine finit(f,s) + + use medians + + real(dbl), intent(in out) :: f + real(dbl), intent(out) :: s + + real(dbl), dimension(:), allocatable :: res,sig + integer :: n + + n = size(flat) + f = median(rat) + allocate(res(n),sig(n)) + call residuals(f,res,sig) + s = median(abs(res/sig)) / 0.6745 + deallocate(res,sig) + + end subroutine finit + + subroutine fnewton(f,df,s,convergent) + + use rfun + + real(dbl), intent(in out) :: f + real(dbl), intent(out) :: df + real(dbl), intent(in) :: s + logical, intent(out) :: convergent + + real(dbl), dimension(:), allocatable :: psi,dpsi,res,sig,rs + real(dbl) :: fun, dfun, fun2, d, xtol + integer :: iter,n + + convergent = .false. + + if( .not. (s > 0) ) return + + n = size(flat) + allocate(psi(n),dpsi(n),res(n),sig(n),rs(n)) + + ! tolerance limit depends on number of elements in sums + ! because every element can include its rounding error... + ! ... proportional to absolute value ... + xtol = 10*n*abs(f)*epsilon(f) + + do iter = 1, precision(f) + + call residuals(f,res,sig) + + rs = res / (s * sig) + call tukeys(rs,psi) + call dtukeys(rs,dpsi) + + fun = -sum(psi*cf/sig) + dfun = sum(dpsi*(cf/sig)**2) + + if( abs(dfun) < epsilon(dfun) ) exit + + ! corrector for mean + d = s * fun / dfun + + ! update location + f = f - d + + if( verb ) write(error_unit,'(a,i2,1pg20.10,1p3g12.3)') & + "mean, incr., f, f': ",iter,f,d,fun,dfun + + convergent = abs(d) < xtol + + ! exit of iterations: the absolute errot must be at least |d| < tol + if( convergent ) exit + + end do + + fun2 = sum(psi**2) ! mean of psi**2 + dfun = dfun * s**2 + if( convergent .and. dfun > 0 .and. fun2 > 0 ) then + df = s*sqrt(fun2/dfun**2*n/(n-1)) ! df is an element of Jacobian + else + df = s/sqrt(real(n)) + end if + + deallocate(res,sig,psi,dpsi,rs) + + end subroutine fnewton + +end module robustflat diff -Nru munipack-0.5.9/vo/Makefile.in munipack-0.5.10/vo/Makefile.in --- munipack-0.5.9/vo/Makefile.in 2017-07-17 23:04:25.000000000 +0000 +++ munipack-0.5.10/vo/Makefile.in 2018-01-16 17:58:15.000000000 +0000 @@ -327,7 +327,6 @@ builddir = @builddir@ datadir = @datadir@ datarootdir = @datarootdir@ -develop = @develop@ docdir = @docdir@ dvidir = @dvidir@ exec_prefix = @exec_prefix@ diff -Nru munipack-0.5.9/vo/votab.cpp munipack-0.5.10/vo/votab.cpp --- munipack-0.5.9/vo/votab.cpp 2017-07-17 23:03:48.000000000 +0000 +++ munipack-0.5.10/vo/votab.cpp 2018-01-16 17:58:04.000000000 +0000 @@ -1,9 +1,8 @@ -/* +/* VOTable parser - - Copyright © 2010 - 2013 F.Hroch (hroch@physics.muni.cz) + Copyright © 2010 - 2013, 2017 F.Hroch (hroch@physics.muni.cz) This file is part of Munipack. @@ -11,12 +10,12 @@ it under the terms of the GNU General Public License as published by the Free Software Foundation, either version 3 of the License, or (at your option) any later version. - + Munipack is distributed in the hope that it will be useful, but WITHOUT ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the GNU General Public License for more details. - + You should have received a copy of the GNU General Public License along with Munipack. If not, see . @@ -69,9 +68,10 @@ wxString output, backup, type, file, sort; wxString pt, mk, ak, dk; double pa, pd, ps, ml; + long pw = -1, ph = -1; wxFFileInputStream pstream(stdin); - wxTextInputStream input(pstream); + wxTextInputStream input(pstream); while(pstream.IsOk() && ! pstream.Eof()) { @@ -101,6 +101,12 @@ if( line.StartsWith("PROJ SCALE") ) ps = GetDouble(line); + if( line.StartsWith("PROJ WIDTH") ) + pw = GetLong(line); + + if( line.StartsWith("PROJ HEIGHT") ) + ph = GetLong(line); + if( line.StartsWith("MAG LIMIT") ) ml = GetDouble(line); @@ -132,7 +138,8 @@ vt.SetMagkey(mk); vt.SetAlphakey(ak); vt.SetDeltakey(dk); - + if( pw > 0 && ph > 0 ) + vt.SetCanvasSize(pw,ph); + return vt.Save(output,backup,type) ? 0 : 1; } - diff -Nru munipack-0.5.9/vo/votable.cpp munipack-0.5.10/vo/votable.cpp --- munipack-0.5.9/vo/votable.cpp 2017-07-17 23:03:48.000000000 +0000 +++ munipack-0.5.10/vo/votable.cpp 2018-01-16 17:58:04.000000000 +0000 @@ -348,7 +348,8 @@ VOTable::VOTable(const wxURL& url): wxXmlDocument(),index(0),timeout(60) { - canvas_size = 200.0; + canvas_width = 500; + canvas_height = 500; mag_limit = 15.0; proj_scale = 1000.0; @@ -384,7 +385,8 @@ VOTable::VOTable(const wxXmlDocument& vt): wxXmlDocument(vt),index(0),timeout(120) { - canvas_size = 200.0; + canvas_width = 500; + canvas_height = 500; mag_limit = 15.0; proj_scale = 1000.0; @@ -436,7 +438,11 @@ proj_alpha = a; proj_delta = d; } -void VOTable::SetSize(double l) { canvas_size = l; } +void VOTable::SetCanvasSize(long w, long h) +{ + canvas_width = w; + canvas_height = h; +} void VOTable::SetScale(double c) { proj_scale = c; } void VOTable::SetMaglim(double x) { mag_limit = x; } void VOTable::SetMagkey(const wxString& a) { mag_key = a; } @@ -785,8 +791,13 @@ // vector tf = TypeTrafo(ft); vector tf = FitsTypes(); vector tu = fu; + + // Vizier catalogues reports magnitude errors (e_Vmag) in an obscure + // format as type character (or short in past) like '02' for 0.02 (!?). + // These values are converted to more convenient form. for(size_t i = 0; i < tf.size(); i++) { if( fu[i] == "cmag" ) { + ft[i] = "float"; tu[i] == "mag"; tf[i] = "1E"; } @@ -815,31 +826,12 @@ double epoch = GetEpoch(); fits_write_key(file,TDOUBLE,"EPOCH",&epoch,"reference time (epoch)",&status); - for(size_t i = 0; i < fs.size(); i++) { + for(size_t i = 0; i < fs.size() && status == 0 ; i++) { vector c = GetColumn(i); size_t n = c.size(); - if( ft[i] == "short" && fu[i] == "cmag" ) { // fucking cmags! - - float *x = new float[n]; - for(size_t j = 0; j < n; j++) { - long t; - if( c[j].ToLong(&t) ) - x[j] = t/100.0; - else { - x[j] = nan(""); - if( c[j] != "" ) { - wxLogError("Failed convert element `"+c[j]+"' at row=%d col="+fs[i]+ - " to float.",(int)j); - } - } - } - fits_write_col(file,TFLOAT,i+1,1,1,n,x,&status); - delete[] x; - - } - else if( ft[i] == "boolean" ) { + if( ft[i] == "boolean" ) { char *x = new char[n]; for(size_t j = 0; j < n; j++) { if( c[j]== "T" || c[j]== "t" || c[j]== "1" ) @@ -957,11 +949,12 @@ } else if( ft[i] == "float" ) { + float scale = fu[i] == "cmag" ? 0.01 : 1.0; float *x = new float[n]; for(size_t j = 0; j < n; j++) { double t; if( c[j].ToDouble(&t) ) - x[j] = t; + x[j] = scale*t; else { x[j] = nan(""); if( c[j] != "" ) { @@ -975,11 +968,12 @@ } else if( ft[i] == "double" ) { + double scale = fu[i] == "cmag" ? 0.01 : 1.0; double *x = new double[n]; for(size_t j = 0; j < n; j++) { double t; if( c[j].ToDouble(&t) ) - x[j] = t; + x[j] = scale*t; else { x[j] = nan(""); if( c[j] != "" ) { @@ -1015,6 +1009,7 @@ } } + if( fits_close_file(file, &status) ) fits_report_error(stderr,status); @@ -1054,7 +1049,9 @@ vector xmag = GetColumn(nmag); wxTextOutputStream cout(output); - cout << "" << endl; + cout << "" << endl; // WARNING: only simple gnonomical projection is implemented @@ -1063,12 +1060,13 @@ double ra = ToDouble(xra[i]); double dec = ToDouble(xdec[i]); double mag = ToDouble(xmag[i]); - double x = canvas_size - proj_scale*(ra - proj_alpha)*c; - double y = canvas_size - proj_scale*(dec - proj_delta);// reverse y-axis !! + double x = canvas_width/2 - proj_scale*(ra - proj_alpha)*c; + double y = canvas_height/2 - proj_scale*(dec - proj_delta);//reverse y-axis! double r = 3.0*pow(10.0,0.11*(mag_limit - mag)); - cout << "" << endl; + if( 0 <= x && x <= canvas_width && 0 <= y && y <= canvas_height ) + cout << "" << endl; } cout << "" << endl; @@ -1170,6 +1168,18 @@ return 666; // formally } +long GetLong(const wxString& line) +{ + long l; + wxString a = line.AfterFirst('='); + + if( a.ToCLong(&l) ) + return l; + + wxLogFatalError("Failed to read the number: "+a); + return 0; // formally +} + bool GetBool(const wxString& line) { wxRegEx re(".+ = (.*)"); diff -Nru munipack-0.5.9/wxMathPlot/Makefile.in munipack-0.5.10/wxMathPlot/Makefile.in --- munipack-0.5.9/wxMathPlot/Makefile.in 2017-07-17 23:04:25.000000000 +0000 +++ munipack-0.5.10/wxMathPlot/Makefile.in 2018-01-16 17:58:15.000000000 +0000 @@ -278,7 +278,6 @@ builddir = @builddir@ datadir = @datadir@ datarootdir = @datarootdir@ -develop = @develop@ docdir = @docdir@ dvidir = @dvidir@ exec_prefix = @exec_prefix@ diff -Nru munipack-0.5.9/xmunipack/astrometry.cpp munipack-0.5.10/xmunipack/astrometry.cpp --- munipack-0.5.9/xmunipack/astrometry.cpp 2017-07-17 23:03:48.000000000 +0000 +++ munipack-0.5.10/xmunipack/astrometry.cpp 2018-01-16 17:58:04.000000000 +0000 @@ -2,7 +2,7 @@ xmunipack - astrometry - Copyright © 2011-5 F.Hroch (hroch@physics.muni.cz) + Copyright © 2011-5,2017 F.Hroch (hroch@physics.muni.cz) This file is part of Munipack. @@ -10,12 +10,12 @@ it under the terms of the GNU General Public License as published by the Free Software Foundation, either version 3 of the License, or (at your option) any later version. - + Munipack is distributed in the hope that it will be useful, but WITHOUT ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the GNU General Public License for more details. - + You should have received a copy of the GNU General Public License along with Munipack. If not, see . @@ -30,7 +30,7 @@ #include #include #include -#include +#include #include #include #include @@ -58,28 +58,30 @@ class MuniAstrometryLayer { public: - MuniAstrometryLayer(int w, int h):ltic(10),gold(wxColour(255,215,0,240)),DarkOrange2(wxColour(238,118,0)), - width(w),height(h),alpha(0.0),delta(0.0),xoff(0.0),yoff(0.0),scale(1.0), - angle(0.0),maglim(18.0) {} + MuniAstrometryLayer(int w, int h): + ltic(10),gold(wxColour(255,215,0,240)),DarkOrange2(wxColour(238,118,0)), + width(w),height(h),alpha(0.0),delta(0.0),xoff(0.0),yoff(0.0),scale(1.0), + angle(0.0),reflex(1.0),maglim(18.0) {} MuniLayer GetLayer() const; bool IsEmpty() const { return objects.empty(); } - void SetProj(const wxString&,double,double,double,double,double,double); + void SetProj(const wxString&,double,double,double,double,double,double, + double); void DrawStars(const FitsTable& table, const wxString&,const wxString&, const wxString&,const wxString&,const wxString&); void DrawCompas(); void DrawMatch(double,const std::vector&,const std::vector&); void Draw3Space(int, const std::vector&); void Draw3Tri(const std::vector&,const std::vector&); - + private: - + const int ltic; const wxColour gold,DarkOrange2; std::vector objects; int width, height; wxString proj; - double alpha,delta,xoff,yoff,scale,angle,maglim; + double alpha,delta,xoff,yoff,scale,angle,reflex,maglim; wxBitmap tribit; @@ -91,7 +93,7 @@ return layer; } -void MuniAstrometryLayer::SetProj(const wxString& t,double a,double d,double x,double y,double s,double f) +void MuniAstrometryLayer::SetProj(const wxString& t,double a,double d,double x,double y,double s,double f, double z) { proj = t; alpha = a; @@ -100,12 +102,16 @@ yoff = y; scale = s; angle = f; + reflex = z; //wxLogDebug(proj+" %f %f %f %f %f %f",a,d,x,y,s,f); } -void MuniAstrometryLayer::DrawStars(const FitsTable& table,const wxString& label_ra, - const wxString& label_dec, const wxString& label_pmra, - const wxString& label_pmdec,const wxString& label_mag) +void MuniAstrometryLayer::DrawStars(const FitsTable& table, + const wxString& label_ra, + const wxString& label_dec, + const wxString& label_pmra, + const wxString& label_pmdec, + const wxString& label_mag) { objects.push_back(new MuniDrawPen(wxPen(gold,1.0))); objects.push_back(new MuniDrawFont(*wxNORMAL_FONT,gold)); @@ -127,37 +133,46 @@ const double *a = table.GetColumn(label_ra).GetCol_double(); const double *d = table.GetColumn(label_dec).GetCol_double(); const float *mag = imag >= 0 ? table.GetColumn(label_mag).GetCol_float() : 0; - double *ppma = ipmra >= 0 ? + double *ppma = ipmra >= 0 ? (double *)table.GetColumn(label_pmra).GetCol_double() : 0; - double *ppmd = ipmdec >= 0 ? + double *ppmd = ipmdec >= 0 ? (double *)table.GetColumn(label_pmdec).GetCol_double() : 0; objects.push_back(new MuniDrawPen(wxPen(gold,1.8))); objects.push_back(new MuniDrawBrush(wxColour(90,90,255,190))); - FitsProjection pr(proj,alpha,delta,xoff,yoff,scale,angle); + FitsProjection pr(proj,alpha,delta,xoff,yoff,scale,angle,reflex); double dt = 2012.8 - 2000.0; // dt = 0.0; for(int i = 0; i < n; i++) { - double x,y; - double pma = ppma ? dt*ppma[i]/3600000.0 : 0.0; - double pmd = ppmd ? dt*ppmd[i]/3600000.0 : 0.0; - - // printf("pm: %f %f %f %f %f %f\n",a[i],d[i],pma,pmd,ppma[i],ppmd[i]); - - pr.ad2xy(a[i]+pma,d[i]+pmd,x,y); - - if( mag ) { - double r = 1.5*pow(10.0,0.11*(maglim - mag[i])); - // double r = 3.0*pow(maglim - mag[i],0.333); - // if( mag[i] > 1.0 ) - objects.push_back(new MuniDrawCircle(x,y,r)); + if( wxFinite(a[i]) && wxFinite(d[i]) && wxFinite(ppma[i]) && + wxFinite(ppmd[i]) && wxFinite(mag[i]) ) { + + double x,y; + double pma = ppma ? dt*ppma[i]/3600000.0 : 0.0; + double pmd = ppmd ? dt*ppmd[i]/3600000.0 : 0.0; + + //wxPrintf("pm: %f %f %f %f %f %f\n",a[i],d[i],pma,pmd,ppma[i],ppmd[i]); + + pr.ad2xy(a[i]+pma,d[i]+pmd,x,y); + + //wxLogDebug("a,d: %f %f, x,y: %f %f",a[i]+pma,d[i]+pmd,x,y); + + if( 0 < x && x < width && 0 < y && y < width ) { + if( mag ) { + double r = 1.5*pow(10.0,0.11*(maglim - mag[i])); + // double r = 3.0*pow(maglim - mag[i],0.333); + // if( mag[i] > 1.0 ) + // wxLogDebug("%f %f %f",x,y,r); + objects.push_back(new MuniDrawCircle(x,y,r)); + } + else + objects.push_back(new MuniDrawCircle(x,y,1.0)); + } } - else - objects.push_back(new MuniDrawCircle(x,y,1.0)); } } } @@ -203,9 +218,9 @@ double f = 90.0*i - angle; double r1 = 3.0*ltic; double r2 = rrose - 4.0*ltic; - double x1 = xoff + r1*cos(f/rad); + double x1 = xoff + r1*cos(f/rad)*reflex; double y1 = yoff + r1*sin(f/rad); - double x2 = xoff + r2*cos(f/rad); + double x2 = xoff + r2*cos(f/rad)*reflex; double y2 = yoff + r2*sin(f/rad); objects.push_back(new MuniDrawLine(x1,y1,x2,y2)); objects.push_back(new MuniDrawText(x2,y2,cp[i])); @@ -318,9 +333,10 @@ // --- MuniAstrometry -MuniAstrometry::MuniAstrometry(wxWindow *w, MuniConfig *c): - wxDialog(w,wxID_ANY,"Astrometry",wxDefaultPosition,wxDefaultSize,wxDEFAULT_DIALOG_STYLE|wxRESIZE_BORDER), - config(c), +MuniAstrometry::MuniAstrometry(wxWindow *w, MuniConfig *c): + wxDialog(w,wxID_ANY,"Astrometry",wxDefaultPosition,wxDefaultSize, + wxDEFAULT_DIALOG_STYLE|wxRESIZE_BORDER), + config(c), timer(this),pipe(this), nhist(0), maglim(18.0), @@ -430,15 +446,15 @@ // title wxBoxSizer *topsizer = new wxBoxSizer(wxVERTICAL); - + wxNotebook *book = new wxNotebook(this,wxID_ANY); - + wxPanel* manpanel = new wxPanel(book); wxBoxSizer *mansizer = new wxBoxSizer(wxVERTICAL); - + wxStaticBoxSizer *psizer = new wxStaticBoxSizer(wxVERTICAL,manpanel,"Projection"); - + wxArrayString projections; projections.Add("Identity"); projections.Add("Gnomonic"); @@ -492,9 +508,14 @@ ss->Add(new wxStaticText(manpanel,wxID_ANY,L"[°]"),cf); grid->Add(ss,cf); + ss = new wxBoxSizer(wxHORIZONTAL); + reflex_checkbox = new wxCheckBox(manpanel,wxID_ANY,"Reflex"); + ss->Add(reflex_checkbox); + grid->Add(ss,cf); + savebutt = new wxButton(manpanel,wxID_ANY,"Save to header"); savebutt->Enable(false); - + wxBoxSizer *st = new wxBoxSizer(wxHORIZONTAL); st->Add(grid,wxSizerFlags().Border().Center()); st->Add(savebutt,wxSizerFlags().Border().Align(wxALIGN_RIGHT|wxALIGN_BOTTOM)); @@ -503,8 +524,8 @@ mansizer->Add(tsizer,wxSizerFlags().Expand().Border()); - // accurate - + // accurate + overlayid = new wxStaticText(manpanel,wxID_ANY,"Overlay: "+astrolog.GetSign()); overlay_check = new wxCheckBox(manpanel,wxID_ANY,"Draw"); overlay_check->SetValue(draw_overlay); @@ -598,7 +619,7 @@ topsizer->Add(book,wxSizerFlags(1).Expand().DoubleBorder()); - wxStdDialogButtonSizer *buttsize = + wxStdDialogButtonSizer *buttsize = static_cast(CreateButtonSizer(wxAPPLY|wxCANCEL)); if( buttsize ) { @@ -634,6 +655,8 @@ Bind(wxEVT_COMMAND_TEXT_UPDATED,&MuniAstrometry::OnTextDouble,this,wscale->GetId()); Bind(wxEVT_COMMAND_TEXT_UPDATED,&MuniAstrometry::OnTextDouble,this,acenter->GetId()); Bind(wxEVT_COMMAND_TEXT_UPDATED,&MuniAstrometry::OnTextDouble,this,dcenter->GetId()); + Bind(wxEVT_COMMAND_CHECKBOX_CLICKED,&MuniAstrometry::OnReflex,this, + reflex_checkbox->GetId()); Bind(wxEVT_COMMAND_TEXT_ENTER,&MuniAstrometry::OnTextDouble,this,wangle->GetId()); Bind(wxEVT_COMMAND_TEXT_ENTER,&MuniAstrometry::OnTextDouble,this,wscale->GetId()); @@ -657,6 +680,7 @@ ids.push_back(catbutt->GetId()); ids.push_back(refbutt->GetId()); ids.push_back(rembutt->GetId()); + ids.push_back(reflex_checkbox->GetId()); } void MuniAstrometry::OnUpdateUI(wxUpdateUIEvent& e) @@ -681,14 +705,15 @@ init_file = false; Reset(); - - if( array.GetWCS(xoff,yoff,alpha,delta,scale,angle) ) { + + if( array.GetWCS(xoff,yoff,alpha,delta,scale,angle,reflex) ) { wscale->SetValue(Scale(scale)); // wangle->SetValue(Period(angle)); wangle->SetValue(angle); acenter->SetValue(alpha); dcenter->SetValue(delta); + reflex_checkbox->SetValue(reflex < 0); init_par = true; @@ -798,6 +823,7 @@ wangle->SetValue("0.0"); acenter->SetValue("0.0"); dcenter->SetValue("0.0"); + reflex_checkbox->SetValue(false); if( array.IsOk() ) { wxASSERT(array.Naxis() == 2); @@ -810,7 +836,7 @@ { FitsTable table; - + FitsFile fits(filename); if( fits.IsOk() ) { @@ -819,12 +845,7 @@ if( ! fits.IsOk() || fits.Hdu(i).Type() != HDU_TABLE ) continue; table = fits.Hdu(i); - - // inform user - wxString a; - a.Printf("%d stars in list.",(int)table.Nrows()); - wxLogDebug(a); - + wxLogDebug("%d stars in list.",(int)table.Nrows()); } } @@ -837,7 +858,7 @@ // finds coordinate keys int ira = catalogue.GetColIndex(label_ra); int idec = catalogue.GetColIndex(label_dec); - + if( ! init_par && (ira >= 0 && idec >= 0) ) { double xx,yy,sx,sy; @@ -849,31 +870,31 @@ for(int i = 0; i < n; i++) { - + double x = a[i]; double y = d[i]; xx = xx + x; yy = yy + y; sx = sx + x*x; sy = sy + y*y; - + } - + if( n > 0 ) { - + alpha = xx/n; delta = yy/n; - + acenter->SetValue(alpha); dcenter->SetValue(delta); - + sx = sqrt(sx/n); // sy = sqrt(sy/n); // wxLogDebug("%f %d %f",sy,n,delta); sy = sqrt(sy/n - delta*delta); - + double r = sy; // in declination, there is no scale contraction - + if( yoff ) { scale = yoff/r; // wxLogDebug("%f %f %f",(float)alpha,(float)delta,(float)scale); @@ -916,17 +937,18 @@ ev.proj = proj; ev.scale = scale; ev.angle = angle; + ev.reflex = reflex; ev.xcen = xoff; ev.ycen = yoff; ev.acen = alpha; ev.dcen = delta; MuniAstrometryLayer l(array.Naxes(0),array.Naxes(1)); - l.SetProj(proj,alpha,delta,xoff,yoff,scale,angle); + l.SetProj(proj,alpha,delta,xoff,yoff,scale,angle,reflex); l.DrawStars(t,label_ra,label_dec,label_pmra,label_pmdec,label_mag); if( page == 0 ) - l.DrawCompas(); + l.DrawCompas(); ev.layer = l.GetLayer(); - wxQueueEvent(GetParent(),ev.Clone()); + wxQueueEvent(GetParent(),ev.Clone()); } else { MuniAstrometryEvent ev(EVT_ASTROMETRY); @@ -956,6 +978,12 @@ edited = true; } +void MuniAstrometry::OnReflex(wxCommandEvent& event) +{ + reflex = event.IsChecked() ? -1 : 1; + DrawOverlay(coverlay); + edited = true; +} void MuniAstrometry::RunProcessing() { @@ -964,7 +992,7 @@ MuniProcess *astrometry = new MuniProcess(&pipe,"astrometry"); astrometry->SetVerbose(false); pipe.push(astrometry); - + astrometry->Write("PIPELOG = T"); astrometry->Write("PROJECTION = '"+proj.Upper()+"'"); astrometry->Write("WCSSAVE = T"); @@ -997,7 +1025,7 @@ astrometry->Write("CAT = '"+catfile+"'"); } else { - if( relative ) + if( relative ) astrometry->Write("REL = '"+reffile+"'"); else astrometry->Write("REF = '"+reffile+"'"); @@ -1009,7 +1037,7 @@ { Bind(wxEVT_END_PROCESS,&MuniAstrometry::OnCalibrateFinish,this); Bind(wxEVT_TIMER,&MuniAstrometry::OnTimer,this); - + wxBeginBusyCursor(); calbutt->Hide(); @@ -1093,7 +1121,7 @@ wxString value(re.GetMatch(out[idx],2)); if( key == "ASTROMETRY" ) { - + if( value.Find("Start") != wxNOT_FOUND ) { progress->SetValue(0); proginfo->SetLabel("Starting..."); @@ -1110,7 +1138,7 @@ else if( key == "ASTROFIT" ) { if( value.Find("Start") != wxNOT_FOUND ) { - + } else if( value.Find("Final") != wxNOT_FOUND ) { @@ -1130,6 +1158,7 @@ wangle->SetValue(angle); acenter->SetValue(alpha); dcenter->SetValue(delta); + // reflex_checkbox->SetValue(); wxString a; a.Printf(" Success (RMS = %.2f "+astropt->GetOutputUnits()+")", @@ -1142,7 +1171,7 @@ } } } - + else if( key == "ASTROMATCH" ) { if( value.Find("Start") != wxNOT_FOUND ) { @@ -1182,7 +1211,7 @@ } else if( key == "AFIT" || key == "RFIT" || key == "MFIT" ) { - + afit = true; wxStringInputStream ss(value); @@ -1190,7 +1219,7 @@ double xcen,ycen; t >> s0 >> scale >> angle >> alpha >> delta >> xcen >> ycen; - } + } else if( key == "MPROGRESO" ) { @@ -1200,7 +1229,7 @@ int ns, ntot; t >> ns >> ntot; - + double r = double(ns)/double(ntot); wxDateTime now; @@ -1217,13 +1246,13 @@ double vel = r/sec.ToDouble(); // velocity in fractions per second wxLongLong est; est.Assign((1 - r)/vel); - + wxTimeSpan dt = wxTimeSpan::Seconds(est); int d = dt.GetDays(); int h = dt.GetHours(); int m = dt.GetMinutes(); wxLongLong s = dt.GetSeconds(); - + // wxLogDebug("%d %d %d "+s.ToString(),d,h,m); wxString ss; @@ -1284,7 +1313,7 @@ x.clear(); y.clear(); if( n > 0 ) { - x.resize(n); y.resize(n); + x.resize(n); y.resize(n); for(int i = 0; i < n; i++) t >> x[i] >> y[i]; } @@ -1293,7 +1322,7 @@ t >> m; u.clear(); v.clear(); if( m > 0 ) { - u.resize(m); v.resize(m); + u.resize(m); v.resize(m); for(int i = 0; i < m; i++) t >> u[i] >> v[i]; } @@ -1314,7 +1343,7 @@ } else if( key == "MTRI" ) { - + wxStringInputStream ss(value); wxTextInputStream t(ss); @@ -1346,9 +1375,9 @@ ev.acen = alpha; ev.dcen = delta; } - layer.SetProj(proj,alpha,delta,xoff,yoff,scale,angle); + layer.SetProj(proj,alpha,delta,xoff,yoff,scale,angle,reflex); // layer.DrawStars(catalogue,label_ra,label_dec,label_pmra,label_pmdec,label_mag); - + layer.Draw3Tri(u,v); if( x.size() > 0 ) { @@ -1356,7 +1385,7 @@ } if( ! layer.IsEmpty() ) { ev.layer = layer.GetLayer(); - wxQueueEvent(GetParent(),ev.Clone()); + wxQueueEvent(GetParent(),ev.Clone()); } } @@ -1377,7 +1406,7 @@ MuniProcess *action = new MuniProcess(&pipe,"wcsupdate"); pipe.push(action); - + action->Write("WCSSAVE = T"); action->Write("PROJECTION = '"+proj.Upper()+"'"); @@ -1417,7 +1446,7 @@ MuniProcess *action = new MuniProcess(&pipe,"wcsremove"); pipe.push(action); - + action->Write("WCSSAVE = T"); action->WriteFile(workingfile); @@ -1453,7 +1482,7 @@ return 3600.0/s; else if( sunit->GetLabel() == ARC_MIN ) return 60.0/s; - else + else return s; } @@ -1496,14 +1525,14 @@ EraseTemp(); if( ms.GetType() == ID_ASTRO_CAT ) { - + tmpcat = ms.IsTemporary(); if( tmpcat ) { catfile = wxFileName::CreateTempFileName("xmunipack-astrometry_"); wxCopyFile(ms.GetPath(),catfile); } else - catfile = ms.GetPath(); + catfile = ms.GetPath(); label_ra = ms.GetLabelRA(); label_dec = ms.GetLabelDec(); label_pmra = ms.GetLabelPMRA(); @@ -1511,7 +1540,7 @@ label_mag = ms.GetLabelMag(); refcatid->SetLabel(ms.GetId()); catalogue = LoadCatalogue(catfile); - if( init_par ) + if( init_par ) InitByCatalogue(catalogue); if( ! coverlay.IsOk() ) { overlayid->SetLabel(ms.GetId()); @@ -1553,4 +1582,3 @@ tip.ShowFor(calbutt); } } - diff -Nru munipack-0.5.9/xmunipack/discanvas.cpp munipack-0.5.10/xmunipack/discanvas.cpp --- munipack-0.5.9/xmunipack/discanvas.cpp 2017-07-17 23:03:48.000000000 +0000 +++ munipack-0.5.10/xmunipack/discanvas.cpp 2018-01-16 17:58:04.000000000 +0000 @@ -2,7 +2,7 @@ xmunipack - display canvas - Copyright © 2012-14 F.Hroch (hroch@physics.muni.cz) + Copyright © 2012-14, 17 F.Hroch (hroch@physics.muni.cz) This file is part of Munipack. @@ -10,12 +10,12 @@ it under the terms of the GNU General Public License as published by the Free Software Foundation, either version 3 of the License, or (at your option) any later version. - + Munipack is distributed in the hope that it will be useful, but WITHOUT ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the GNU General Public License for more details. - + You should have received a copy of the GNU General Public License along with Munipack. If not, see . @@ -102,7 +102,7 @@ void MuniDisplayCanvas::OnScroll(wxScrollWinEvent& event) { - rendering = true; + rendering = true; event.Skip(); } @@ -142,6 +142,7 @@ void MuniDisplayCanvas::OnPaint(wxPaintEvent& event) { + // wxLogDebug("OnPaint"); wxPaintDC dc(this); /* @@ -184,7 +185,7 @@ int yb = wxMax(yw/z,0); int wb = wxMin(ww/z + 1,icon.GetWidth()); int hb = wxMin(hw/z + 1,icon.GetHeight()); - + bool wt = 0 < wb && wb <= icon.GetWidth(); bool ht = 0 < hb && hb <= icon.GetHeight(); bool xt = xb >= 0 && xb + wb <= icon.GetWidth(); @@ -229,12 +230,10 @@ upd++; } - - // for(size_t i = 0; i < layers.size(); i++) - list::const_iterator i = layers.begin(); + // Layers + list::const_iterator i; for(i = layers.begin(); i != layers.end(); ++i) DrawLayer(dc,*i); - // DrawLayer(dc,layers[i]); } @@ -324,22 +323,20 @@ int hv = wxMax(h,hc); SetVirtualSize(wv,hv); - - xoff = wxMax((wv - w)/2,0); - yoff = wxMax((hv - h)/2,0); - - // wxLogDebug("%d %d %d %d %f",w,h,xoff,yoff,z); if( z > 1.0 ) canvas = wxImage(w0,h0); else canvas = wxImage(w,h); + xoff = wxMax((wc - canvas.GetWidth())/2,0); + yoff = wxMax((hc - canvas.GetHeight())/2,0); + // wxLogDebug("%d %d %d %d %f",w,h,xoff,yoff,z); + canvas.InitAlpha(); for(int i = 0; i < canvas.GetWidth(); i++) for(int j = 0; j < canvas.GetHeight(); j++) canvas.SetAlpha(i,j,wxIMAGE_ALPHA_TRANSPARENT); - } @@ -412,26 +409,26 @@ h = wxMin(hs,fitsimage.GetHeight()); y = 0; } - + x = 0; y = 0; w = fitsimage.GetWidth(); h = fitsimage.GetHeight(); - + wxASSERT(zoom > 0.0); - if( xoff > 0 ) + if( xoff > 0 ) x = 0; else x = wxMax(x0,0)/zoom; - if( yoff > 0 ) + if( yoff > 0 ) y = 0; else y = wxMax(fitsimage.GetHeight() - (hs + y0)/zoom,0); + w = wxMin(fitsimage.GetWidth(),ws/zoom); h = wxMin(fitsimage.GetHeight(),hs/zoom); - // wxLogDebug("%f %d %d %d %d %d %d %d %d %d %d",zoom,x,y,w,h,x0,y0,wc,hc,xoff,yoff); @@ -468,7 +465,7 @@ canvas.SetRGB(wxRect(k,l,1,1),img.GetRed(i,j),img.GetGreen(i,j),img.GetBlue(i,j)); canvas.SetAlpha(k,l,wxIMAGE_ALPHA_OPAQUE); } - } + } Refresh(); } @@ -509,7 +506,7 @@ } } -void MuniDisplayCanvas::ConvertCoo(double u, double v, double& x, double&y) +void MuniDisplayCanvas::ConvertCoo(double u, double v, double& x, double& y) { double height = canvas.GetHeight(); if( zoom > 1.0 ) height = zoom*height; @@ -518,11 +515,18 @@ y = yoff + height - zoom*v; x = x - vbX; y = y - vbY; + + /* + x = u; + y = height - v; + */ } void MuniDisplayCanvas::DrawLayer(wxPaintDC& dc, const MuniLayer& layer) { + // wxLogDebug("DrawLayer"); // wxStopWatch sw; + //DoPrepareDC(dc); double height = canvas.GetHeight(); @@ -550,7 +554,7 @@ float y = yoff + (height - zoom*circle->y); dc.DrawCircle(x,y,d); } - + MuniDrawLine *line = dynamic_cast(*i); if( line ) { wxPoint2DDouble points[2]; @@ -563,13 +567,13 @@ MuniDrawText *text = dynamic_cast(*i); if( text ) { dc.DrawText(text->text,zoom*text->x,height-zoom*text->y); - } + } } } */ - // wxLogDebug("%f %f %f %d %d %d ",(float)xoff,(float)yoff,(float)zoom,vbX,vbY,height); + // wxLogDebug("%f %f %f %f %f %f ",(float)xoff,(float)yoff,(float)zoom,(float)vbX,(float)vbY,height); wxGraphicsContext *gc = wxGraphicsContext::Create(dc); if( gc ) { @@ -587,6 +591,8 @@ // gc->SetBrush(wxBrush(wxColour(90,90,255,130))); // gc->SetBrush(*wxBLUE_BRUSH); // gc->SetPen(wxPen(*wxWHITE,1)); + // gc->DrawEllipse(100.0,100.0,100.0,100.0); + vector::const_iterator i; vector objects = layer.GetObjects(); @@ -603,16 +609,17 @@ MuniDrawCircle *circle = dynamic_cast(*i); if( circle ) { - double d = 2.0*circle->r/**zoom*/; + double r = wxMax(circle->r * zoom,2); + double d = 2*r; + double x,y; ConvertCoo(circle->x,circle->y,x,y); - x = x - circle->r; - y = y - circle->r; - // double x = xoff + zoom*circle->x - circle->r; - // double y = yoff + height - zoom*circle->y - circle->r; + //wxLogDebug("%f %f %f %f",x,y,circle->r,d); + x = x - r; + y = y - r; gc->DrawEllipse(x,y,d,d); } - + MuniDrawLine *line = dynamic_cast(*i); if( line ) { wxPoint2DDouble points[2]; @@ -621,6 +628,7 @@ points[0] = wxPoint2DDouble(x,y); ConvertCoo(line->x2,line->y2,x,y); points[1] = wxPoint2DDouble(x,y); + // wxLogDebug("%f %f %f %f %f %f",line->x1,line->y1,line->x2,line->y2,x,y); /* points[0] = wxPoint2DDouble(xoff+zoom*line->x1,yoff+height-zoom*line->y1); points[1] = wxPoint2DDouble(xoff+zoom*line->x2,yoff+height-zoom*line->y2); @@ -679,16 +687,16 @@ double x,y; ConvertCoo(bitmap->x,bitmap->y-bitmap->h,x,y); gc->DrawBitmap(bitmap->bitmap,x,y,bitmap->w,bitmap->h); - + // gc->DrawBitmap(bitmap->bitmap,xoff+bitmap->x,yoff+(height-bitmap->y-bitmap->h),bitmap->w,bitmap->h); } - + } gc->EndLayer(); delete gc; - } - + } + // wxLogDebug("Drawing took: %f sec",sw.Time()/1000.0); } @@ -699,7 +707,7 @@ // wxGraphicsContext *gc = wxGraphicsContext::Create(dc); // if( gc ) { - + // // default colors // gc->SetBrush(wxBrush(*wxBLUE)); // gc->SetPen(wxPen(*wxYELLOW,1)); @@ -714,7 +722,7 @@ // wxXmlAttribute *prop = child->GetAttributes(); // while(prop) { - + // wxString a = prop->GetValue(); // double x; // a.ToDouble(&x); @@ -731,7 +739,7 @@ // prop = prop->GetNext(); // } // gc->StrokeLine(x1,y1,x2,y2); - + // } // else if( child->GetName() == "text") { @@ -752,7 +760,7 @@ // y = t; // prop = prop->GetNext(); -// } +// } // gc->DrawText(text,x,y); // } @@ -776,7 +784,7 @@ // r = x; // prop = prop->GetNext(); -// } +// } // gc->DrawEllipse(cx-r/2.0,cy-r/2.0,r,r); // } @@ -809,16 +817,16 @@ // wxLogDebug("%d %d %d %d",evt.i_x,evt.i_y,evt.z_x,evt.z_y); int size = config->detail_zoom; - + int x = evt.i_x; int y = evt.i_y; - + int x1 = x - size/2; int y1 = y - size/2; int x2 = x + size/2; int y2 = y + size/2; - if( fitsimage.IsOk() && + if( fitsimage.IsOk() && x1 > 0 && y1 > 0 && x2 < fitsimage.GetWidth() && y2 < fitsimage.GetHeight() ){ evt.picture = display.GetImage(fitsimage.GetSubImage(x1,y1,size,size)); } @@ -830,7 +838,7 @@ if( ! dragging ) { - + SetCursor(wxCursor(wxCURSOR_HAND)); xdrag0 = event.GetLogicalPosition(dc).x; ydrag0 = event.GetLogicalPosition(dc).y; @@ -911,7 +919,7 @@ } if( keycode == WXK_ESCAPE ) { - StopRendering(); + StopRendering(); return; } @@ -929,7 +937,7 @@ case WXK_RIGHT: id = wxID_FORWARD; break; } } - + if( id != wxID_ANY ) { wxQueueEvent(topwin,new wxCommandEvent(wxEVT_COMMAND_MENU_SELECTED,id)); return; @@ -940,9 +948,9 @@ long y = event.GetY(); switch(keycode) { - case WXK_LEFT: + case WXK_LEFT: x--; break; - case WXK_UP: + case WXK_UP: y--; break; case WXK_RIGHT: x++; break; @@ -1057,11 +1065,11 @@ */ astrometry = e.astrometry; - // layers.clear(); + layers.clear(); if( astrometry ) { - // wxLogDebug(e.proj+" %f %f %f",e.xcen,e.ycen,e.scale); + //wxLogDebug(e.proj+" %f %f %f",e.xcen,e.ycen,e.scale); aangle = e.angle; ascale = e.scale; @@ -1071,7 +1079,8 @@ ycen = e.ycen; // layers.push_back(e.svg); layers.push_back(e.layer); - // wxLogDebug("%d",(int)e.layer.objects.size()); +// wxLogDebug("astrometryevent: %d",(size_t)e.layer.objects.size()); +// wxLogDebug("astrometryevent: %d",(size_t)e.layer.IsEmpty()); } Refresh(); @@ -1083,7 +1092,7 @@ if( e.erase ) RemoveLayers(ID_PHOTOMETRY); - else + else layers.push_back(e.layer); Refresh(); @@ -1162,7 +1171,7 @@ wxGraphicsContext *gc = wxGraphicsContext::Create(mdc); if( gc ) { - + gc->SetBrush(wxBrush(*wxBLUE)); gc->SetPen(wxPen(*wxYELLOW,1)); @@ -1184,9 +1193,9 @@ wxImage i = layer.ConvertToImage(); i.SetMaskColour(0,0,0); - + overlay.push_back(wxBitmap(i)); - + } */ @@ -1203,7 +1212,7 @@ // wxGraphicsContext *gc = wxGraphicsContext::Create(mdc); // if( gc ) { - + // gc->SetBrush(wxBrush(*wxBLUE)); // gc->SetPen(wxPen(*wxYELLOW,1,wxPENSTYLE_SOLID)); @@ -1215,7 +1224,7 @@ // /* // vector::const_iterator i; // for(i = paths.begin(); i != paths.end(); ++i) { - // */ + // */ // gc->StrokePath(path); @@ -1225,19 +1234,19 @@ // wxImage i = layer.ConvertToImage(); // i.SetMaskColour(0,0,0); - + // overlay.push_back(wxBitmap(i)); - + //} // ---- ImageRender --------------------------------- -ImageRender::ImageRender(wxEvtHandler *eh, const FitsImage& fi, - const FitsImage& fis, const FitsDisplay& d, +ImageRender::ImageRender(wxEvtHandler *eh, const FitsImage& fi, + const FitsImage& fis, const FitsDisplay& d, double zz, bool z, int x, int y, int w, int h): - wxThread(wxTHREAD_DETACHED),handler(eh),fitsimage(fi), fimage(fis), + wxThread(wxTHREAD_DETACHED),handler(eh),fitsimage(fi), fimage(fis), display(d), zoom(zz), zooming(z),x0(x),y0(y),width(w),height(h) { wxASSERT(handler && fitsimage.IsOk() && x >= 0 && y >= 0 && h > 0 && w > 0); @@ -1261,7 +1270,7 @@ #ifdef __WXDEBUG__ wxStopWatch sw; -#endif +#endif // length of square side // This value is choosed to be the duration of a single iteration @@ -1281,7 +1290,7 @@ newimage = fitsimage;//.GetSubImage(x0,y0,width,height); // newimage.Rescale(zoom); } - + // wxLogDebug("Init took: %d msec",(int)sw.Time()); @@ -1321,7 +1330,7 @@ // wxASSERT(w > i && h > j); - // wxASSERT(x0 <= i && i < + // wxASSERT(x0 <= i && i < dx = wxMin(imax - i,side); dy = wxMin(jmax - j,side); @@ -1329,7 +1338,7 @@ wxASSERT(dx > 0 && dy > 0 && fimage.IsOk()); FitsImage sub(fimage.GetSubImage(i,j,dx,dy)); - + if( zooming ) { FitsImage z(sub.Scale(zoom)); sub = z; @@ -1341,7 +1350,7 @@ // wxLogDebug("sub: %d %d %d %d",x,y,newimage.GetWidth(),newimage.GetHeight()); wxASSERT(sub.IsOk()); // newimage.SetSubImage(x,y,sub); - + wxASSERT(sub.IsOk()); MuniRenderEvent ev(EVT_RENDER,ID_SUBRENDER); @@ -1379,4 +1388,3 @@ // wxLogDebug("Rendering took: %f sec",sw.Time()/1000.0); return (wxThread::ExitCode) 0; } - diff -Nru munipack-0.5.9/xmunipack/dispanel.cpp munipack-0.5.10/xmunipack/dispanel.cpp --- munipack-0.5.9/xmunipack/dispanel.cpp 2017-07-17 23:03:48.000000000 +0000 +++ munipack-0.5.10/xmunipack/dispanel.cpp 2018-01-16 17:58:04.000000000 +0000 @@ -2,7 +2,7 @@ xmunipack - display panel - Copyright © 2012-4 F.Hroch (hroch@physics.muni.cz) + Copyright © 2012-4, 2017 F.Hroch (hroch@physics.muni.cz) This file is part of Munipack. @@ -10,12 +10,12 @@ it under the terms of the GNU General Public License as published by the Free Software Foundation, either version 3 of the License, or (at your option) any later version. - + Munipack is distributed in the hope that it will be useful, but WITHOUT ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the GNU General Public License for more details. - + You should have received a copy of the GNU General Public License along with Munipack. If not, see . @@ -39,7 +39,7 @@ config(c) { SetScrollRate(-1,1); - + wxColour bc(wxSystemSettings::GetColour(wxSYS_COLOUR_WINDOWFRAME)); wxFont bf(*wxITALIC_FONT); @@ -56,7 +56,7 @@ // sdetail.Add(_("Contours")); // wxChoice *dtvalue = new wxChoice(this,wxID_ANY,wxDefaultPosition, - // wxDefaultSize,sdetail); + // wxDefaultSize,sdetail); // wxStaticBoxSizer *zsizer = new wxStaticBoxSizer(wxVERTICAL,this); // zsizer->Add(zoom,wxSizerFlags().Align(wxALIGN_CENTER_VERTICAL|wxALIGN_CENTER_HORIZONTAL).Border(wxTOP|wxBOTTOM)); // zsizer->Add(dtvalue,wxSizerFlags().Expand().Align(wxALIGN_BOTTOM)); @@ -66,20 +66,20 @@ wxBoxSizer *vs = new wxBoxSizer(wxHORIZONTAL); value_label = new wxStaticText(this,wxID_ANY,L"Value (!,?)"); vs->Add(value_label,wxSizerFlags().Align(wxALIGN_CENTER_VERTICAL|wxALIGN_LEFT)); - wxButton *inttype = new wxButton(this,wxID_ANY,L"»",wxDefaultPosition, + wxButton *inttype = new wxButton(this,wxID_ANY,L"»",wxDefaultPosition, wxDefaultSize,wxBU_EXACTFIT); vs->AddStretchSpacer(); vs->Add(inttype,wxSizerFlags().Align(wxALIGN_RIGHT)); - val = new wxTextCtrl(this, wxID_ANY, wxEmptyString,wxDefaultPosition, + val = new wxTextCtrl(this, wxID_ANY, wxEmptyString,wxDefaultPosition, wxDefaultSize, DefaultStyle); val->SetBackgroundColour(bc); val->SetToolTip("Any value. An instrumental intensity in counts (ADU)"); - + wxBoxSizer *valsizer = new wxBoxSizer(wxVERTICAL); valsizer->Add(vs,wxSizerFlags().Expand()); valsizer->Add(val,wxSizerFlags().Expand()); - + // coordinates wxBoxSizer *cs = new wxBoxSizer(wxHORIZONTAL); @@ -94,7 +94,7 @@ wxStaticText *la = new wxStaticText(this,wxID_ANY,L"α"); la->SetFont(bf); xgrid->Add(la,wxSizerFlags().Align(wxALIGN_CENTER_VERTICAL)); - acoo = new wxTextCtrl(this, wxID_ANY, wxEmptyString,wxDefaultPosition, + acoo = new wxTextCtrl(this, wxID_ANY, wxEmptyString,wxDefaultPosition, wxDefaultSize, DefaultStyle); acoo->SetBackgroundColour(bc); acoo->SetToolTip("Spherical coordinate - longitude"); @@ -103,7 +103,7 @@ wxStaticText *ld = new wxStaticText(this,wxID_ANY,L"δ"); ld->SetFont(bf); xgrid->Add(ld,wxSizerFlags().Align(wxALIGN_CENTER_VERTICAL)); - dcoo = new wxTextCtrl(this, wxID_ANY, wxEmptyString,wxDefaultPosition, + dcoo = new wxTextCtrl(this, wxID_ANY, wxEmptyString,wxDefaultPosition, wxDefaultSize, DefaultStyle); dcoo->SetBackgroundColour(bc); dcoo->SetToolTip("Spherical coordinate - latitude"); @@ -112,7 +112,7 @@ wxStaticText *lx = new wxStaticText(this,wxID_ANY,"x"); lx->SetFont(bf); xgrid->Add(lx,wxSizerFlags().Align(wxALIGN_CENTER_VERTICAL)); - xcoo = new wxTextCtrl(this, wxID_ANY, wxEmptyString,wxDefaultPosition, + xcoo = new wxTextCtrl(this, wxID_ANY, wxEmptyString,wxDefaultPosition, wxDefaultSize, DefaultStyle); xcoo->SetBackgroundColour(bc); xcoo->SetToolTip("Rectangular horizontal coordinate in pixels. Origin at left bottom corner."); @@ -121,7 +121,7 @@ wxStaticText *ly = new wxStaticText(this,wxID_ANY,"y"); ly->SetFont(bf); xgrid->Add(ly,wxSizerFlags().Align(wxALIGN_CENTER_VERTICAL)); - ycoo = new wxTextCtrl(this, wxID_ANY, wxEmptyString,wxDefaultPosition, + ycoo = new wxTextCtrl(this, wxID_ANY, wxEmptyString,wxDefaultPosition, wxDefaultSize, DefaultStyle); ycoo->SetBackgroundColour(bc); ycoo->SetToolTip("Rectangular vertical coordinate in pixels. Origin at left bottom corner."); @@ -139,16 +139,16 @@ wxStaticText *lobject = new wxStaticText(this,wxID_ANY,"Object:"); lobject->SetFont(bf); igrid->Add(lobject,wxSizerFlags().Align(wxALIGN_CENTER_VERTICAL)); - wxTextCtrl *iobj = new wxTextCtrl(this, wxID_ANY, wxEmptyString,wxDefaultPosition, + wxTextCtrl *iobj = new wxTextCtrl(this, wxID_ANY, wxEmptyString,wxDefaultPosition, wxDefaultSize, wxTE_RIGHT|wxTE_DONTWRAP|wxTE_READONLY); iobj->SetBackgroundColour(bc); iobj->SetToolTip("Target object name"); igrid->Add(iobj,wxSizerFlags().Expand()); - + wxStaticText *ldate = new wxStaticText(this,wxID_ANY,"Date:"); ldate->SetFont(bf); igrid->Add(ldate,wxSizerFlags().Align(wxALIGN_CENTER_VERTICAL|wxRIGHT)); - wxTextCtrl *idate = new wxTextCtrl(this, wxID_ANY, wxEmptyString,wxDefaultPosition, + wxTextCtrl *idate = new wxTextCtrl(this, wxID_ANY, wxEmptyString,wxDefaultPosition, wxDefaultSize, wxTE_RIGHT|wxTE_DONTWRAP|wxTE_READONLY); idate->SetBackgroundColour(bc); idate->SetToolTip("Date of exposure start in UT"); @@ -157,7 +157,7 @@ wxStaticText *ltime = new wxStaticText(this,wxID_ANY,"Time:"); ltime->SetFont(bf); igrid->Add(ltime,wxSizerFlags().Align(wxALIGN_CENTER_VERTICAL)); - wxTextCtrl *itime = new wxTextCtrl(this, wxID_ANY, wxEmptyString,wxDefaultPosition, + wxTextCtrl *itime = new wxTextCtrl(this, wxID_ANY, wxEmptyString,wxDefaultPosition, wxDefaultSize, wxTE_RIGHT|wxTE_DONTWRAP|wxTE_READONLY); itime->SetBackgroundColour(bc); itime->SetToolTip("Time of exposure start in UT"); @@ -166,7 +166,7 @@ wxStaticText *lexp = new wxStaticText(this,wxID_ANY,"Etime:"); lexp->SetFont(bf); igrid->Add(lexp,wxSizerFlags().Align(wxALIGN_CENTER_VERTICAL)); - wxTextCtrl *iexp = new wxTextCtrl(this, wxID_ANY, wxEmptyString,wxDefaultPosition, + wxTextCtrl *iexp = new wxTextCtrl(this, wxID_ANY, wxEmptyString,wxDefaultPosition, wxDefaultSize, wxTE_RIGHT|wxTE_DONTWRAP|wxTE_READONLY); iexp->SetToolTip("Exposure time in seconds"); iexp->SetBackgroundColour(bc); @@ -175,7 +175,7 @@ wxStaticText *lband = new wxStaticText(this,wxID_ANY,"Band:"); lband->SetFont(bf); igrid->Add(lband,wxSizerFlags().Align(wxALIGN_CENTER_VERTICAL)); - wxTextCtrl *iband = new wxTextCtrl(this, wxID_ANY, wxEmptyString,wxDefaultPosition, + wxTextCtrl *iband = new wxTextCtrl(this, wxID_ANY, wxEmptyString,wxDefaultPosition, wxDefaultSize, wxTE_RIGHT|wxTE_DONTWRAP|wxTE_READONLY); iband->SetBackgroundColour(bc); iband->SetToolTip("Spectral band description"); @@ -184,7 +184,7 @@ wxStaticText *lsize = new wxStaticText(this,wxID_ANY,"Size:"); lsize->SetFont(bf); igrid->Add(lsize,wxSizerFlags().Align(wxALIGN_CENTER_VERTICAL)); - wxTextCtrl *isize = new wxTextCtrl(this, wxID_ANY, wxEmptyString,wxDefaultPosition, + wxTextCtrl *isize = new wxTextCtrl(this, wxID_ANY, wxEmptyString,wxDefaultPosition, wxDefaultSize, wxTE_RIGHT|wxTE_DONTWRAP|wxTE_READONLY); isize->SetBackgroundColour(bc); @@ -204,7 +204,7 @@ topsizer->Add(coosizer,wxSizerFlags().Expand().Border()); /* topsizer->Add(new wxStaticLine(this,wxID_ANY),wxSizerFlags().Expand().Border()); - topsizer->Add(igrid,wxSizerFlags().Expand()); + topsizer->Add(igrid,wxSizerFlags().Expand()); */ topsizer->Add(new wxStaticLine(this,wxID_ANY),wxSizerFlags().Expand().Border(wxLEFT|wxRIGHT)); topsizer->Add(phisto,wxSizerFlags().Expand().Border()); @@ -232,8 +232,8 @@ void MuniDisplayPanel::SetHdu(const FitsArray& h, const FitsHisto& hist) { hdu = h; - value = FitsValue(hdu,config->phsystemfile, config->fits_key_area, - config->fits_key_gain, config->fits_key_exptime, + value = FitsValue(hdu,config->phsystemfile, config->fits_key_area, + config->fits_key_gain, config->fits_key_exptime, config->fits_key_filter); coords = FitsCoo(hdu); @@ -283,7 +283,7 @@ if( l[i] == label ) popup.Check(id,true); if( value.HasCal() ) { - if( i == 0 ) + if( i == 0 ) popup.Enable(id,false); } else { @@ -449,8 +449,3 @@ event.SetText(tsize); } */ - - - - - diff -Nru munipack-0.5.9/xmunipack/display.cpp munipack-0.5.10/xmunipack/display.cpp --- munipack-0.5.9/xmunipack/display.cpp 2017-07-17 23:03:48.000000000 +0000 +++ munipack-0.5.10/xmunipack/display.cpp 2018-01-16 17:58:04.000000000 +0000 @@ -2,7 +2,7 @@ xmunipack - display image - Copyright © 2009-2013 F.Hroch (hroch@physics.muni.cz) + Copyright © 2009-2013, 2017 F.Hroch (hroch@physics.muni.cz) This file is part of Munipack. @@ -10,12 +10,12 @@ it under the terms of the GNU General Public License as published by the Free Software Foundation, either version 3 of the License, or (at your option) any later version. - + Munipack is distributed in the hope that it will be useful, but WITHOUT ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the GNU General Public License for more details. - + You should have received a copy of the GNU General Public License along with Munipack. If not, see . @@ -60,7 +60,7 @@ topsizer->Add(canvas,wxSizerFlags(1).Expand()); topsizer->Add(panel,wxSizerFlags().Expand().Border(wxLEFT|wxRIGHT)); SetSizerAndFit(topsizer); - + Bind(wxEVT_CLOSE_WINDOW,&MuniDisplay::OnClose,this); Bind(wxEVT_ENTER_WINDOW,&MuniDisplay::OnEnterWin,this); // Bind(wxEVT_LEAVE_WINDOW,&MuniDisplay::OnLeaveWin,this); @@ -200,7 +200,7 @@ wxMemoryOutputStream ostream; table.GetStarChart(ostream); - + wxMemoryInputStream istream(ostream); // MuniSvg svg(istream); // static_cast(canvas)->AddOverlay(svg.GetDrawObjects()); @@ -237,7 +237,7 @@ if( a.ToDouble(&x) ) r = x; } - + prop = prop->GetNext(); } @@ -255,12 +255,14 @@ { wxASSERT(canvas); - double x0, y0, a0, d0, scale, phi; + double x0, y0, a0, d0, scale, phi, reflex; const int ntics = 25; - double tics[25] = { 90.0, 60.0, 30.0, 10.0, 5.0, 2.0, 1.0, 0.5, 0.2, 0.1, 0.05, 0.02, 0.01, - 0.005, 0.002, 0.001, 0.0005, 0.0002, 0.0001, 5e-5, 2e-5, 1e-5, 5e-6, 2e-6, 1e-6}; + double tics[25] = { 90.0, 60.0, 30.0, 10.0, 5.0, 2.0, 1.0, 0.5, 0.2, 0.1, + 0.05, 0.02, 0.01, + 0.005, 0.002, 0.001, 0.0005, 0.0002, 0.0001, 5e-5, 2e-5, + 1e-5, 5e-6, 2e-6, 1e-6}; - if( show && array.GetWCS(x0,y0,a0,d0,scale,phi) ) { + if( show && array.GetWCS(x0,y0,a0,d0,scale,phi,reflex) ) { vector objects; wxColour bfont(91,95,255); @@ -279,7 +281,7 @@ if( fabs(phi) < 45.0 ) { // declination - FitsProjection p("",a0,d0,x0,y0,scale,phi); + FitsProjection p("",a0,d0,x0,y0,scale,phi,reflex); // wxLogDebug("%f %f %f %f %f %f",a0,d0,x0,y0,scale,phi); double amin, amax, dmin, dmax, atic, dtic; @@ -294,7 +296,7 @@ dtic = tics[i]; break; } - + atic = dtic; double dstart = int(d0/dtic)*dtic; @@ -324,9 +326,9 @@ } } - + for(size_t i = 0; i < decs.size() && ras.size() > 0; i++) { - + double x1,y1,x2,y2,x,y; p.ad2xy(ras[0],decs[i],x1,y1); p.ad2xy(ras[0]-atic,decs[i],x,y); @@ -344,7 +346,7 @@ } for(size_t i = 0; i < ras.size() && decs.size() > 0; i++) { - + double x1,y1,x2,y2,x,y; p.ad2xy(ras[i],decs[0],x1,y1); p.ad2xy(ras[i],decs[0]-dtic,x,y); @@ -379,7 +381,7 @@ wxString a; a.Printf(fmt,ras[i]); objects.push_back(new MuniDrawText(x,-1.0,a)); - } + } for(size_t i = 0; i < decs.size() && ras.size() > 0; i++) { double x,y; @@ -387,8 +389,8 @@ wxString a; a.Printf(fmt,decs[i]); objects.push_back(new MuniDrawText(-1.0,y,1.57,a)); - } - + } + } MuniLayer layer(ID_GRID,objects); @@ -396,7 +398,7 @@ // static_cast(canvas)->ShowGrid(layer); static_cast(canvas)->AddLayer(layer); } - else + else // static_cast(canvas)->HideGrid(); static_cast(canvas)->RemoveLayers(ID_GRID); } @@ -407,22 +409,22 @@ if( show ) { for(size_t i = 0; i < fits.HduCount(); i++) { - if( fits.Hdu(i).GetExtname() == APEREXTNAME || + if( fits.Hdu(i).GetExtname() == APEREXTNAME || fits.Hdu(i).GetExtname() == PHCALNAME ) { FitsTable table(fits.Hdu(i)); const double *x = table.GetColumn(FITS_LABEL_X).GetCol_double(); const double *y = table.GetColumn(FITS_LABEL_Y).GetCol_double(); double *f = 0; - if( fits.Hdu(i).GetExtname() == APEREXTNAME ) + if( fits.Hdu(i).GetExtname() == APEREXTNAME ) f = (double *) table.GetColumn(FITS_LABEL_APCOUNT "1").GetCol_double(); - else if( fits.Hdu(i).GetExtname() == PHCALNAME ) + else if( fits.Hdu(i).GetExtname() == PHCALNAME ) f = (double *) table.GetColumn(FITS_COL_PHOTONS).GetCol_double(); vector xcoo,ycoo,flux; for(long i = 0; i < table.Nrows(); i++) { xcoo.push_back(x[i]); ycoo.push_back(y[i]); - if( f ) + if( f ) flux.push_back(f[i]); } @@ -443,7 +445,7 @@ if( array.IsColor() ) tune = new MuniTune(this,ID_TUNE,GetPosition(),wxDefaultSize,config,array,GetItt(),GetColor()); - else + else tune = new MuniTune(this,ID_TUNE,GetPosition(),wxDefaultSize,config,array,GetItt(),GetPalette()); tune->Show(true); @@ -480,7 +482,7 @@ /* wxString cfile = calibrate.GetResult(); - + FitsFile fits(cfile); if( fits.IsOk() ) @@ -552,18 +554,15 @@ - separate the long image sequence and resize images to single exposures: - for A in `seq 0 55`; do - P=$((A*48)); - X=$(printf "%02d" $A); + for A in `seq 0 55`; do + P=$((A*48)); + X=$(printf "%02d" $A); convert moon_56frames.png -crop 48x48+$P+1 -resize 32x32 m_$X.png; done - animate: - + convert -delay 10 +repage m_*.png throbbler.gif */ - - - diff -Nru munipack-0.5.9/xmunipack/event.h munipack-0.5.10/xmunipack/event.h --- munipack-0.5.9/xmunipack/event.h 2017-07-17 23:03:48.000000000 +0000 +++ munipack-0.5.10/xmunipack/event.h 2018-01-16 17:58:04.000000000 +0000 @@ -2,7 +2,7 @@ XMunipack - derived events - Copyright © 2009-2012 F.Hroch (hroch@physics.muni.cz) + Copyright © 2009-2012, 2017 F.Hroch (hroch@physics.muni.cz) This file is part of Munipack. @@ -10,12 +10,12 @@ it under the terms of the GNU General Public License as published by the Free Software Foundation, either version 3 of the License, or (at your option) any later version. - + Munipack is distributed in the hope that it will be useful, but WITHOUT ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the GNU General Public License for more details. - + You should have received a copy of the GNU General Public License along with Munipack. If not, see . @@ -82,13 +82,15 @@ class MuniAstrometryEvent: public wxCommandEvent { public: - MuniAstrometryEvent(WXTYPE e =wxEVT_NULL, int id =wxID_ANY): wxCommandEvent(e,id), - scale(0.0),angle(0.0),xcen(0.0),ycen(0.0),acen(0.0),dcen(0.0),astrometry(false) {} - MuniAstrometryEvent(wxCommandEvent& e): wxCommandEvent(e), - scale(0.0),angle(0.0),xcen(0.0),ycen(0.0),acen(0.0),dcen(0.0),astrometry(false) {} + MuniAstrometryEvent(WXTYPE e =wxEVT_NULL, int id =wxID_ANY): + wxCommandEvent(e,id), scale(0.0),reflex(1.0),angle(0.0),xcen(0.0), + ycen(0.0),acen(0.0),dcen(0.0),astrometry(false) {} + MuniAstrometryEvent(wxCommandEvent& e): + wxCommandEvent(e), scale(0.0), reflex(1.0),angle(0.0),xcen(0.0),ycen(0.0), + acen(0.0),dcen(0.0),astrometry(false) {} wxEvent *Clone(void) const { return new MuniAstrometryEvent(*this); } wxString proj; - double scale,angle,xcen,ycen,acen,dcen; + double scale,reflex,angle,xcen,ycen,acen,dcen; bool astrometry; MuniLayer layer; }; @@ -133,7 +135,7 @@ class MuniRenderEvent: public wxThreadEvent { public: - MuniRenderEvent(WXTYPE commandEventType =wxEVT_NULL, int id =wxID_ANY): + MuniRenderEvent(WXTYPE commandEventType =wxEVT_NULL, int id =wxID_ANY): wxThreadEvent(commandEventType,id),x(0),y(0) {} MuniRenderEvent(wxThreadEvent& e): wxThreadEvent(e),x(0),y(0) {} wxEvent *Clone(void) const { return new MuniRenderEvent(*this); } @@ -173,7 +175,7 @@ class MetaOpenEvent: public wxThreadEvent { public: - MetaOpenEvent(WXTYPE commandEventType =wxEVT_NULL, int id =wxID_ANY): + MetaOpenEvent(WXTYPE commandEventType =wxEVT_NULL, int id =wxID_ANY): wxThreadEvent(commandEventType,id) {} MetaOpenEvent(wxThreadEvent& e): wxThreadEvent(e) {} wxEvent *Clone(void) const { return new MetaOpenEvent(*this); } @@ -191,7 +193,7 @@ class MuniDialogEvent: public wxCommandEvent { public: - MuniDialogEvent(WXTYPE commandEventType =wxEVT_NULL, int id =wxID_ANY): + MuniDialogEvent(WXTYPE commandEventType =wxEVT_NULL, int id =wxID_ANY): wxCommandEvent(commandEventType,id), return_code(0) {} MuniDialogEvent(wxCommandEvent& e): wxCommandEvent(e), return_code(0) {} wxEvent *Clone(void) const { return new MuniDialogEvent(*this); } @@ -202,4 +204,3 @@ wxDECLARE_EVENT(EVT_DIALOG,MuniDialogEvent); #define MuniDialogEventHandler(func) (&func) - diff -Nru munipack-0.5.9/xmunipack/fitscoo.cpp munipack-0.5.10/xmunipack/fitscoo.cpp --- munipack-0.5.9/xmunipack/fitscoo.cpp 2017-07-17 23:03:48.000000000 +0000 +++ munipack-0.5.10/xmunipack/fitscoo.cpp 2018-01-16 17:58:04.000000000 +0000 @@ -1,20 +1,20 @@ -/* +/* xmunipack - coordinates - - Copyright © 1997-2013 F.Hroch (hroch@physics.muni.cz) - + + Copyright © 1997-2013, 2017 F.Hroch (hroch@physics.muni.cz) + This file is part of Munipack. - + Munipack is free software: you can redistribute it and/or modify it under the terms of the GNU General Public License as published by the Free Software Foundation, either version 3 of the License, or (at your option) any later version. - + Munipack is distributed in the hope that it will be useful, but WITHOUT ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the GNU General Public License for more details. - + You should have received a copy of the GNU General Public License along with Munipack. If not, see . @@ -33,17 +33,23 @@ // ----------------------------------------------------------------- FitsProjection::FitsProjection(): - acen(0.0),dcen(0.0),xcen(0.0),ycen(0.0),scale(1.0),angle(0.0) {} + acen(0.0),dcen(0.0),xcen(0.0),ycen(0.0),scale(1.0),angle(0.0),reflex(1.0) {} -FitsProjection::FitsProjection(const wxString& t, double a,double d,double x,double y,double s,double r): - type(t.Upper()),acen(a/RAD),dcen(d/RAD),xcen(x),ycen(y),scale(s*RAD),angle(r/RAD) {} +FitsProjection::FitsProjection(const wxString& t, double a,double d,double x, + double y,double s,double r,double z): + type(t.Upper()),acen(a/RAD),dcen(d/RAD),xcen(x),ycen(y),scale(s*RAD), + angle(r/RAD), reflex(z) {} -FitsProjection::FitsProjection(const wxString& t, double a,double d, double x, double y, double cd11, double cd12, double cd21, double cd22): - type(t.Upper()),acen(a/RAD),dcen(d/RAD),xcen(x),ycen(y),scale(1.0/RAD),angle(0.0) +FitsProjection::FitsProjection(const wxString& t, double a,double d, double x, + double y, double cd11, double cd12, double cd21, + double cd22): + type(t.Upper()),acen(a/RAD),dcen(d/RAD),xcen(x),ycen(y),scale(1.0/RAD), + angle(0.0), reflex(1.0) { + reflex = -cd11*cd22 > 0 ? 1.0 : -1.0; scale = RAD/sqrt(cd11*cd11 + cd12*cd12); - angle = atan2(cd12,cd22); + angle = atan2(reflex*cd12,cd22); } @@ -55,8 +61,8 @@ double u,v; gnomon(a/RAD,d/RAD,u,v); - x = xcen + aa*u + bb*v; - y = ycen - bb*u + aa*v; + x = xcen + (aa*u + bb*v)*reflex; + y = ycen + (-bb*u + aa*v); } void FitsProjection::xy2ad(double x,double y,double& a,double& d) @@ -68,7 +74,7 @@ u = x - xcen; v = y - ycen; - xx = aa*u - bb*v; + xx = (aa*u - bb*v)*reflex; yy = bb*u + aa*v; ignomon(xx,yy,a,d); @@ -80,7 +86,7 @@ void FitsProjection::gnomon(double a,double d,double& x,double& y) { double c,p,q,r,v,w,s; - + c = cos(d); p = sin(d); q = c*sin(a - acen); @@ -88,7 +94,7 @@ v = sin(dcen); w = cos(dcen); s = p*v + r*w; - + x = -q/s; y = (w*p - v*r)/s; } @@ -103,7 +109,7 @@ p = (v + w*y)/t; q = -x/t; r = (w - v*y)/t; - + d = asin(p); a = atan2(q,r) + acen; } @@ -139,7 +145,7 @@ { return haswcs; } - + void FitsCoo::SetType(int t) { type = static_cast(t); @@ -160,7 +166,7 @@ } void FitsCoo::GetEq(int xcen, int ycen, double& alpha, double& delta) -{ +{ proj.xy2ad(xcen,ycen,alpha,delta); } @@ -185,7 +191,7 @@ wxString FitsCoo::Get_str(int i, int j) -{ +{ wxString a,b; GetStr(i,j,a,b); @@ -200,7 +206,7 @@ void FitsCoo::GetStr(int i, int j, wxString& a, wxString& b) -{ +{ int h,min,d,m; double x,y, sec,s; char sg; @@ -216,7 +222,7 @@ } else if( haswcs ) { - GetEq(i,j,x,y); + GetEq(i,j,x,y); if( type == COO_EQDEG ) { a.Printf(L"%.5f°",x); @@ -224,7 +230,7 @@ } else if( type == COO_EQSIX ) { - RaSix(x,h,min,sec); + RaSix(x,h,min,sec); DecSix(y,sg,d,m,s); a.Printf(L"%02d:%02d:%06.3fs",h,min,sec); b.Printf(L"%c%02d°%02d'%05.2f\"",sg,d,m,s); @@ -234,7 +240,7 @@ } void FitsCoo::GetPix(int i, int j, wxString& a, wxString& b) -{ +{ if( 0 <= i && i < Width() && 0 <= j && j < Height() ) { a.Printf("%d",i+1); b.Printf("%d",j+1); @@ -246,14 +252,14 @@ } void FitsCoo::GetCoo(int i, int j, wxString& a, wxString& b) -{ +{ if( haswcs && 0 <= i && i < Width() && 0 <= j && j < Height() ) { int h,min,d,m; double x,y, sec,s; char sg; - GetEq(i,j,x,y); + GetEq(i,j,x,y); if( type == COO_EQDEG ) { a.Printf(L"%.5f°",x); @@ -261,7 +267,7 @@ } else if( type == COO_EQSIX ) { - RaSix(x,h,min,sec); + RaSix(x,h,min,sec); DecSix(y,sg,d,m,s); a.Printf(L"%02d:%02d:%06.3fs",h,min,sec); b.Printf(L"%c%02d°%02d'%05.2f\"",sg,d,m,s); diff -Nru munipack-0.5.9/xmunipack/fits.cpp munipack-0.5.10/xmunipack/fits.cpp --- munipack-0.5.9/xmunipack/fits.cpp 2017-07-17 23:03:48.000000000 +0000 +++ munipack-0.5.10/xmunipack/fits.cpp 2018-01-16 17:58:04.000000000 +0000 @@ -2,7 +2,7 @@ xmunipack - fits implementation - Copyright © 1997 - 2014 F.Hroch (hroch@physics.muni.cz) + Copyright © 1997 - 2014, 2017 F.Hroch (hroch@physics.muni.cz) This file is part of Munipack. @@ -10,12 +10,12 @@ it under the terms of the GNU General Public License as published by the Free Software Foundation, either version 3 of the License, or (at your option) any later version. - + Munipack is distributed in the hope that it will be useful, but WITHOUT ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the GNU General Public License for more details. - + You should have received a copy of the GNU General Public License along with Munipack. If not, see . @@ -48,7 +48,7 @@ // * 2d color (3d, unique sizes, header with CSPACE keyword) // * 3d (3d spectrum) ? // * multilayer (more layers, arbitrary sizes) -// +// @@ -75,11 +75,11 @@ case 16: return "0 .. 65535"; case 32: return "0 .. 4294967296"; case -32:return L"0 .. ± 10^38, 6 digits"; - default: + default: wxString a; a.Printf("Bitpix = %d",bitpix); return a; - } + } } bool FitsHeader::ParseRecord(const wxString& record, wxString& key, @@ -108,7 +108,7 @@ } */ - + char *i1 = index(cval,'\''); char *i2 = rindex(cval,'\''); if( i1 != NULL && i2 != NULL && i1 != i2 ) { @@ -120,7 +120,7 @@ value = cval; value.Trim(); - + return true; } @@ -187,17 +187,17 @@ // ------ FitsHDU -size_t FitsHdu::GetCount() const -{ - return header.GetCount(); +size_t FitsHdu::GetCount() const +{ + return header.GetCount(); } -wxString FitsHdu::Item(size_t i) const -{ - return header.Item(i); +wxString FitsHdu::Item(size_t i) const +{ + return header.Item(i); } -wxString FitsHdu::GetKey(const wxString& a) const +wxString FitsHdu::GetKey(const wxString& a) const { return header.GetKey(a); } @@ -216,28 +216,28 @@ return l.ToDouble(&x) ? x : 0.0; } -wxString FitsHdu::GetUnit(const wxString& a) const +wxString FitsHdu::GetUnit(const wxString& a) const { return header.GetUnit(a); } -int FitsHdu::Bitpix() const -{ - return header.Bitpix(); +int FitsHdu::Bitpix() const +{ + return header.Bitpix(); } -wxString FitsHdu::Bitpix_str() const -{ - return header.Bitpix_str(); +wxString FitsHdu::Bitpix_str() const +{ + return header.Bitpix_str(); } wxString FitsHdu::Exposure_str(const wxString& a) const { - return header.Exposure_str(a); + return header.Exposure_str(a); } -int FitsHdu::Type() const -{ +int FitsHdu::Type() const +{ return type; } @@ -251,43 +251,43 @@ } } -int FitsHdu::Flavour() const -{ - return HDU_DUMMY; +int FitsHdu::Flavour() const +{ + return HDU_DUMMY; } -wxString FitsHdu::Flavour_str() const -{ - return wxEmptyString; +wxString FitsHdu::Flavour_str() const +{ + return wxEmptyString; } -int FitsHdu::Naxis() const -{ +int FitsHdu::Naxis() const +{ return 0; } -long FitsHdu::Naxes(int n) const -{ +long FitsHdu::Naxes(int n) const +{ return 0; } long FitsHdu::Width() const -{ +{ return Naxes(0); } -long FitsHdu::Height() const -{ - return Naxes(1); +long FitsHdu::Height() const +{ + return Naxes(1); } bool FitsHdu::IsOk() const -{ - return ! header.IsEmpty(); +{ + return ! header.IsEmpty(); } bool FitsHdu::IsColor() const -{ +{ return Naxis() == 3; } @@ -296,11 +296,11 @@ return GetKey("EXTNAME"); } -bool FitsHdu::GetWCS(double& xpix, double& ypix, double& alpha, double& delta, double& scale, double& angle) const +bool FitsHdu::GetWCS(double& xpix, double& ypix, double& alpha, double& delta, double& scale, double& angle, double& reflex) const { // projection is silently ignored wxString type(GetKey("CTYPE1")); - + if( type.IsEmpty() ) return false; xpix = GetKeyDouble("CRPIX1"); @@ -315,8 +315,9 @@ cd21 = GetKeyDouble("CD2_1"); cd22 = GetKeyDouble("CD2_2"); + reflex = -cd11*cd22 >= 0 ? 1.0 : -1.0; scale = 1.0/sqrt(cd11*cd11 + cd12*cd12); - angle = (45.0/atan(1.0)) * atan2(cd12,cd22); + angle = (45.0/atan(1.0)) * atan2(cd21,cd22); return true; } @@ -327,12 +328,12 @@ FitsArrayData::FitsArrayData(): naxis(0),naxes(0),array(0) {} -FitsArrayData::FitsArrayData(int n, long *ns, float *a): +FitsArrayData::FitsArrayData(int n, long *ns, float *a): naxis(n),naxes(ns),array(a) {} -FitsArrayData::FitsArrayData(const FitsArrayData& copy) -{ +FitsArrayData::FitsArrayData(const FitsArrayData& copy) +{ wxFAIL_MSG("FitsArrayData ----- WE ARE REALY NEED COPY CONSTRUCTOR ---"); } @@ -343,17 +344,17 @@ } -FitsArrayData::~FitsArrayData() -{ - delete[] naxes; - delete[] array; +FitsArrayData::~FitsArrayData() +{ + delete[] naxes; + delete[] array; } FitsArray::FitsArray(): npixels(0) {} FitsArray::FitsArray(const FitsHdu& h, int n, long *ns, float *a): FitsHdu(h) -{ +{ wxASSERT( n >= 0 && ns && a ); type = HDU_IMAGE; @@ -369,7 +370,7 @@ FitsArray::FitsArray(const FitsHdu& h): FitsHdu(h) -{ +{ wxASSERT(h.Type() == HDU_IMAGE && h.IsOk()); FitsArrayData *data = static_cast(GetRefData()); @@ -426,13 +427,13 @@ } long FitsArray::Naxes(int n) const -{ +{ FitsArrayData *data = static_cast(m_refData); wxASSERT(data); - if( 0 <= n && n < data->naxis ) - return data->naxes[n]; - else + if( 0 <= n && n < data->naxis ) + return data->naxes[n]; + else return 0; } @@ -508,7 +509,7 @@ // if( dx > 0 && dy > 0 ) // wxLogDebug(_("%d %d"),dx,dy); - + // int ww = i2 - i1 + 1; // int hh = j2 - j1 + 1; // ww = dx; @@ -584,7 +585,7 @@ npixels = npixels*m; } */ - + const FitsArrayData *data = static_cast(m_refData); wxASSERT(data); const float *array = data->array; @@ -595,9 +596,9 @@ // for(int l = 0; l < Naxis(); l++) // if( l != n ) memcpy(a,array+n*npixels,npixels*sizeof(float)); - + // for(int l = 0; l < npixels; l++) a[l] = 1; - + return FitsArray(*this,np,ns,a); } @@ -628,7 +629,7 @@ if( x < min ) min = x; } med = QMed(nd,d,nd/2+1); - + // mad = median of absolute deviations int n = 0; int imax = Npixels() - bstep; @@ -664,7 +665,7 @@ while( x < a[j] && j > l) j--; if( i <= j ) { w = a[i]; a[i] = a[j]; a[j] = w; i++; j--; } - + } while ( i <= j ); if( j < k ) l = i; @@ -708,11 +709,11 @@ // ---------- FitsTable -FitsTableColumnData::FitsTableColumnData(): +FitsTableColumnData::FitsTableColumnData(): typecode(0),nrows(0),otable(0),btable(0),stable(0),itable(0), ltable(0),ftable(0),dtable(0),ctable(0) {} -FitsTableColumnData::FitsTableColumnData(int t, long n, float *d): +FitsTableColumnData::FitsTableColumnData(int t, long n, float *d): typecode(t),nrows(n),otable(0),btable(0),stable(0),itable(0), ltable(0),ftable(d),dtable(0),ctable(0) {} @@ -720,7 +721,7 @@ typecode(t),nrows(n),otable(0),btable(0),stable(0),itable(d), ltable(0),ftable(0),dtable(0),ctable(0) {} -FitsTableColumnData::FitsTableColumnData(int t, long n, char **d): +FitsTableColumnData::FitsTableColumnData(int t, long n, char **d): typecode(t),nrows(n),otable(0),btable(0),stable(0),itable(0), ltable(0),ftable(0),dtable(0),ctable(d) {} @@ -762,10 +763,10 @@ } -FitsTableColumnData::FitsTableColumnData(const FitsTableColumnData& copy) -{ +FitsTableColumnData::FitsTableColumnData(const FitsTableColumnData& copy) +{ wxFAIL_MSG("FitsTableColumn ---- WE ARE REALY NEED COPY CONSTRUCTOR ----"); - + } FitsTableColumnData& FitsTableColumnData::operator = (const FitsTableColumnData& other) @@ -780,56 +781,56 @@ FitsTableColumn::~FitsTableColumn() {} FitsTableColumn::FitsTableColumn(int t, long nr, float *d) -{ +{ UnRef(); SetRefData(new FitsTableColumnData(t,nr,d)); } FitsTableColumn::FitsTableColumn(int t, long nr, double *d) -{ +{ UnRef(); SetRefData(new FitsTableColumnData(t,nr,d)); } FitsTableColumn::FitsTableColumn(int t, long nr, long *d) -{ +{ UnRef(); SetRefData(new FitsTableColumnData(t,nr,d)); } FitsTableColumn::FitsTableColumn(int t, long nr, int *d) -{ +{ UnRef(); SetRefData(new FitsTableColumnData(t,nr,d)); } FitsTableColumn::FitsTableColumn(int t, long nr, short *d) -{ +{ UnRef(); SetRefData(new FitsTableColumnData(t,nr,d)); } FitsTableColumn::FitsTableColumn(int t, long nr, char *d) -{ +{ UnRef(); SetRefData(new FitsTableColumnData(t,nr,d)); } FitsTableColumn::FitsTableColumn(int t, long nr, bool *d) -{ +{ UnRef(); SetRefData(new FitsTableColumnData(t,nr,d)); } FitsTableColumn::FitsTableColumn(int t, long nr, char **d) -{ +{ UnRef(); SetRefData(new FitsTableColumnData(t,nr,d)); } /* FitsTableColumn::FitsTableColumn(const FitsTableColumn& copy) -{ +{ } FitsTableColumn& FitsTableColumn::operator = (const FitsTableColumn& other) @@ -839,15 +840,15 @@ } */ -int FitsTableColumn::GetColType() const -{ +int FitsTableColumn::GetColType() const +{ FitsTableColumnData *data = static_cast(m_refData); wxASSERT(data); return data->typecode; }; -long FitsTableColumn::Nrows() const -{ +long FitsTableColumn::Nrows() const +{ FitsTableColumnData *data = static_cast(m_refData); wxASSERT(data); return data->nrows; @@ -942,7 +943,7 @@ for(int i = 0; i < olddata->nrows; i++) newdata->ctable[i] = wxStrdup(olddata->ctable[i]); } - else + else wxFAIL_MSG("FitsTableColumn::CloneRefData: Unknown data type."); return newdata; @@ -961,19 +962,19 @@ // FitsTableData::FitsTableData(): ncols(0),columns(0) {} // /* -// FitsTableData::FitsTableData(long nr, long nc, float *t): +// FitsTableData::FitsTableData(long nr, long nc, float *t): // nrows(nr),ncols(nc),table(t) {} // */ -// FitsTableData::FitsTableData(long nc): ncols(nc) +// FitsTableData::FitsTableData(long nc): ncols(nc) // { // columns = new FitsTableColumn[nc]; // for(int i = 0; i < nc; i++) // columns[i] = 0; // } -// FitsTableData::FitsTableData(const FitsTableData& copy) -// { +// FitsTableData::FitsTableData(const FitsTableData& copy) +// { // wxFAIL_MSG("FitsTableData ---- WE ARE REALY NEED COPY CONSTRUCTOR ----"); // } @@ -985,7 +986,7 @@ // FitsTableData::~FitsTableData() -// { +// { // delete[] columns; // /* @@ -1003,7 +1004,7 @@ // delete[] a; // } // */ - + // // delete[] table[i]; // // } // // delete[] typecode; @@ -1057,12 +1058,12 @@ } -FitsTable::FitsTable(const FitsHdu& h): +FitsTable::FitsTable(const FitsHdu& h): FitsHdu(h),fits_type(h.Flavour()) // fits_type(static_cast(h).fits_type)//, // columns(static_cast(h).columns) // FitsHdu(h),fits_type(h.Flavour()),columns(static_cast(h).columns) -{ +{ wxASSERT(h.Type() == HDU_TABLE && h.IsOk()); // wxLogDebug("FitsTable::FitsTable(const FitsHdu& h): "); @@ -1115,8 +1116,8 @@ // newdata->columns = new FitsDataColumn[newdata->ncols]; // for(int i = 0; i < olddata->ncols; i++) { // newdata->columns[i] = olddata->columns[i]; - - + + // /* // int len = 1; @@ -1145,11 +1146,11 @@ // table[i] = (void *) new float[olddata->nrows]; // memcpy(table,olddata->table[i],olddata->nrows*sizeof(float)); // } - - + + // } - + // newdata->table = new void**[]; @@ -1342,14 +1343,14 @@ { for(size_t i = 0; i < GetCount(); i++) { wxString key,val,com; - + FitsHeader::ParseRecord(Item(i),key,val,com); - + if( label.StartsWith(val) ) { wxRegEx re("TTYPE([0-9]+)"); wxASSERT(re.IsValid()); - + if( re.Matches(key) ) { wxString a(re.GetMatch(key,1)); long i; @@ -1368,7 +1369,7 @@ for(size_t i = 0; i < GetCount(); i++) { wxString key,val,com; - + FitsHeader::ParseRecord(Item(i),key,val,com); if( key.StartsWith("TTYPE") ) @@ -1400,7 +1401,7 @@ float y = Pixel(1,i); float f = Pixel(11,i); - + if( f > 0 ) { float r = wxMax(f/1e4,10.0); cout << " 0 ) { - long *naxes = new long[naxis]; + long *naxes = new long[naxis]; fits_get_img_size(f,naxis,naxes,&stat); if( stat ) { delete[] naxes; goto crash; } @@ -1497,12 +1498,12 @@ // FitsTable table(head,htype,nrows,ncols); vector cols; - long frow = 1, felem = 1; + long frow = 1, felem = 1; for(int k = 0; k < ncols; k++ ) { int colnum = k + 1; int typecode; - long repeat, width; + long repeat, width; fits_get_coltype(f,colnum,&typecode,&repeat,&width,&stat); if( stat ) goto crash; @@ -1515,49 +1516,49 @@ a[i] = new char[width]; char nullval[width]; strcpy(nullval," "); - fits_read_col(f,TSTRING,colnum, frow, felem, nrows, &nullval, + fits_read_col(f,TSTRING,colnum, frow, felem, nrows, &nullval, a,&dummy,&stat); cols.push_back(FitsTableColumn(typecode,nrows,a)); } else if( typecode == TLOGICAL ) { bool *b = new bool[nrows]; bool nullval = false; - fits_read_col(f,TLOGICAL,colnum, frow, felem, nrows, &nullval, + fits_read_col(f,TLOGICAL,colnum, frow, felem, nrows, &nullval, b,&dummy,&stat); cols.push_back(FitsTableColumn(typecode,nrows,b)); } else if( typecode == TBYTE || typecode == TBIT ) { char *b = new char[nrows]; char nullval = 0; - fits_read_col(f,TBYTE,colnum, frow, felem, nrows, &nullval, + fits_read_col(f,TBYTE,colnum, frow, felem, nrows, &nullval, b,&dummy,&stat); cols.push_back(FitsTableColumn(typecode,nrows,b)); } else if( typecode == TSHORT ) { short *d = new short[nrows]; short nullval = 0; - fits_read_col(f,TSHORT,colnum, frow, felem, nrows, &nullval, + fits_read_col(f,TSHORT,colnum, frow, felem, nrows, &nullval, d,&dummy,&stat); cols.push_back(FitsTableColumn(typecode,nrows,d)); } else if( typecode == TLONG || typecode == TINT32BIT ) { long *d = new long[nrows]; long nullval = 0; - fits_read_col(f,TLONG,colnum, frow, felem, nrows, &nullval, + fits_read_col(f,TLONG,colnum, frow, felem, nrows, &nullval, d,&dummy,&stat); cols.push_back(FitsTableColumn(typecode,nrows,d)); } else if( typecode == TFLOAT ) { float *d = new float[nrows]; float nullval = 0.0; - fits_read_col(f,TFLOAT,colnum, frow, felem, nrows, &nullval, + fits_read_col(f,TFLOAT,colnum, frow, felem, nrows, &nullval, d,&dummy,&stat); cols.push_back(FitsTableColumn(typecode,nrows,d)); } else if( typecode == TDOUBLE ) { double *d = new double[nrows]; double nullval = 0.0; - fits_read_col(f,TDOUBLE,colnum, frow, felem, nrows, &nullval, + fits_read_col(f,TDOUBLE,colnum, frow, felem, nrows, &nullval, d,&dummy,&stat); cols.push_back(FitsTableColumn(typecode,nrows,d)); } @@ -1565,7 +1566,7 @@ wxLogDebug("FitsFile::FitsFile: The type code `%d' not implemented yet.",typecode); /* - fits_read_col(f, TFLOAT,colnum, frow, felem, nrows, &nullval, + fits_read_col(f, TFLOAT,colnum, frow, felem, nrows, &nullval, table+k*nrows,&dummy,&stat); */ #ifdef __WXDEBUG__ @@ -1618,24 +1619,24 @@ hdu.clear(); } -bool FitsFile::Status() const -{ - return status; +bool FitsFile::Status() const +{ + return status; } -size_t FitsFile::HduCount() const -{ - return hdu.size(); +size_t FitsFile::HduCount() const +{ + return hdu.size(); } -int FitsFile::size() const -{ - return hdu.size(); +int FitsFile::size() const +{ + return hdu.size(); } -FitsHdu FitsFile::Hdu(size_t n) const +FitsHdu FitsFile::Hdu(size_t n) const { - wxASSERT(0 <= n && n < hdu.size()); + wxASSERT(0 <= n && n < hdu.size()); return hdu[n]; } @@ -1804,13 +1805,13 @@ fits_create_img(f, FLOAT_IMG, naxis, naxes, &status); merge_head(f,Hdu(k),&status); fits_write_img(f, TFLOAT, fpixel, nelements, (float *) image.PixelData(), &status); - + } else if( type == HDU_TABLE ) { const FitsTable table(Hdu(k)); - + int tfields = table.Ncols(); char **ttype = new char*[tfields]; char **tform = new char*[tfields]; @@ -1938,7 +1939,7 @@ } } - if( ! presented ) + if( ! presented ) fits_write_record(f,record.fn_str(),status); } @@ -1993,7 +1994,6 @@ } fits_close_file(f,&stat); fits_report_error(stderr,stat); - + return cols; } - diff -Nru munipack-0.5.9/xmunipack/fits.h munipack-0.5.10/xmunipack/fits.h --- munipack-0.5.9/xmunipack/fits.h 2017-07-17 23:03:48.000000000 +0000 +++ munipack-0.5.10/xmunipack/fits.h 2018-01-16 17:58:04.000000000 +0000 @@ -2,7 +2,7 @@ XMunipack - FITS headers - Copyright © 2009-2013 F.Hroch (hroch@physics.muni.cz) + Copyright © 2009-2013, 2017 F.Hroch (hroch@physics.muni.cz) This file is part of Munipack. @@ -10,12 +10,12 @@ it under the terms of the GNU General Public License as published by the Free Software Foundation, either version 3 of the License, or (at your option) any later version. - + Munipack is distributed in the hope that it will be useful, but WITHOUT ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the GNU General Public License for more details. - + You should have received a copy of the GNU General Public License along with Munipack. If not, see . @@ -55,14 +55,14 @@ }; enum hdu_flavour { - HDU_IMAGE_LINE, HDU_IMAGE_FRAME, HDU_IMAGE_CUBE, HDU_IMAGE_COLOR, + HDU_IMAGE_LINE, HDU_IMAGE_FRAME, HDU_IMAGE_CUBE, HDU_IMAGE_COLOR, HDU_IMAGE_UNKNOWN, HDU_TABLE_BIN, HDU_TABLE_ASCII, HDU_TABLE_UNKNOWN, HDU_DUMMY }; enum itt_type { - ITT_FIRST, + ITT_FIRST, ITT_LINE, ITT_ASINH, ITT_LOG, ITT_SQRT, ITT_GAMMA, ITT_NORM, ITT_LOGIS, ITT_ATAN, ITT_SQR, ITT_LAST @@ -76,14 +76,14 @@ enum color_palette { PAL_FIRST, - PAL_GREY, PAL_SEPIA, PAL_VGA, PAL_AIPS0, PAL_STAIR, PAL_COLOR, PAL_SAW, - PAL_RAIN, PAL_MAD, PAL_COOL, PAL_HEAT, PAL_SPRING, PAL_WRAP, + PAL_GREY, PAL_SEPIA, PAL_VGA, PAL_AIPS0, PAL_STAIR, PAL_COLOR, PAL_SAW, + PAL_RAIN, PAL_MAD, PAL_COOL, PAL_HEAT, PAL_SPRING, PAL_WRAP, PAL_LAST }; enum color_space { COLORSPACE_FIRST, - COLORSPACE_XYZ, + COLORSPACE_XYZ, COLORSPACE_LAST }; @@ -92,14 +92,14 @@ }; enum units_type { - UNIT_FIRST, - UNIT_COUNT, UNIT_MAG, UNIT_PHOTON, UNIT_FLUX, UNIT_FNU, UNIT_FLAM, UNIT_ABMAG, + UNIT_FIRST, + UNIT_COUNT, UNIT_MAG, UNIT_PHOTON, UNIT_FLUX, UNIT_FNU, UNIT_FLAM, UNIT_ABMAG, UNIT_STMAG, UNIT_LAST }; enum coords_type { - COO_FIRST, + COO_FIRST, COO_PIXEL, COO_EQDEG, COO_EQSIX, COO_LAST }; @@ -160,7 +160,8 @@ virtual inline float Pixel(int, int) const { return 0; } virtual inline wxString Pixel_str(int, int) const; - virtual bool GetWCS(double&,double&,double&,double&,double&,double&) const; + virtual bool GetWCS(double&,double&,double&,double&,double&,double&, + double&) const; protected: @@ -205,7 +206,7 @@ FitsArray(const FitsHdu&); virtual ~FitsArray(); FitsArray Copy() const; - + int Naxis() const; long Naxes(const int n) const; inline float Pixel(int) const; @@ -218,7 +219,7 @@ wxString Flavour_str() const; bool IsOk() const; - + protected: wxObjectRefData* CreateRefData() const; @@ -230,7 +231,7 @@ }; -inline float FitsArray::Pixel(int i) const +inline float FitsArray::Pixel(int i) const { FitsArrayData *data = static_cast(m_refData); wxASSERT(data); @@ -265,7 +266,7 @@ private: float med, mad, min, max; - float QMed(int, float *, int); + float QMed(int, float *, int); }; @@ -373,10 +374,16 @@ a.Printf("%g",data->ftable[x]); else if( data->dtable ) a.Printf("%lg",data->dtable[x]); - else if( data->itable ) + else if( data->stable ) + a.Printf("%d",data->stable[x]); + else if( data->ltable ) a.Printf("%ld",data->ltable[x]); else if( data->itable ) a.Printf("%d",data->itable[x]); + else if( data->btable ) + a.Printf("%d",data->btable[x]); + else if( data->otable ) + a = data->otable[x] ? "T" : "F"; else if( data->ctable ) a = data->ctable[x]; @@ -528,7 +535,7 @@ /* switch(data->typecode[y]) { - case TBYTE: + case TBYTE: case TINT: case TLONG: a.Printf("%d",(int **) data->table[x*data->nrows + y]); break; @@ -599,7 +606,7 @@ void Recognize(); int merge_head(fitsfile *, const FitsHdu&, int *) const; - + }; @@ -609,7 +616,7 @@ { public: FitsMetaHdu(const FitsHdu&, const wxImage&); - FitsMetaHdu(const wxArrayString&, const wxImage&, int, long, + FitsMetaHdu(const wxArrayString&, const wxImage&, int, long, const std::vector&, const wxString&, const wxString&); size_t Naxis() const; @@ -692,16 +699,16 @@ class FitsHisto: public wxObject { -public: +public: FitsHisto(); FitsHisto(int,int*,float*); FitsHisto(const FitsArray& , int=0); FitsHisto(const FitsArray& , float, float, int=0); virtual ~FitsHisto(); - + int NBins() const; - int Hist(int n) const; + int Hist(int n) const; float Cents(int n) const; float BinWidth() const; float CentsMin() const; @@ -722,11 +729,11 @@ { public: FitsGeometry(const FitsArray&); - + FitsArray Scale(float); FitsArray Scale(const long *); FitsArray Scale(int,int); - + FitsArray SubArray(int,int,int,int); void SetSubArray(int,int,const FitsArray&); @@ -839,9 +846,9 @@ void NightVision(int,float*,float*,float*,float*); void Instr_XYZ(int,size_t,const float **,float*,float*,float*); void TuneColors(int,float*,float*,float*); - + float Scotopic(float,float,float); - // void Convert(float, float, float, + // void Convert(float, float, float, // unsigned char &, unsigned char &, unsigned char &); // void Transform(size_t, float *, float&, float&, float&); @@ -899,7 +906,7 @@ float u1 = u/s + uwhite; float v1 = v/s + vwhite; - if( L <= 8.0 ) + if( L <= 8.0 ) Y = L*0.0011071*Yn; /* = powf(3.0/29.0,3) */ else { float t = (L + 16.0)/116.0; @@ -919,7 +926,7 @@ public: FitsPalette(int =PAL_GREY); virtual ~FitsPalette(); - + void SetPalette(int); void SetPalette(const wxString&); void SetNegative(bool=false); @@ -927,7 +934,7 @@ int GetPalette() const; wxString GetPalette_str() const; bool GetNegative() const; - + unsigned char R(int i) const; unsigned char G(int i) const; unsigned char B(int i) const; @@ -936,12 +943,12 @@ const unsigned char *RData() const; const unsigned char *GData() const; const unsigned char *BData() const; - + static wxString Type_str(int); static wxArrayString Type_str(); - + private: - + int pal; bool negative; @@ -956,18 +963,20 @@ { public: FitsProjection(); - FitsProjection(const wxString& t, double a,double d,double x,double y,double s,double r); - FitsProjection(const wxString& t, double a,double d, double x, double y, double cd11, double cd12, double cd21, double cd22); - + FitsProjection(const wxString& t, double a,double d,double x,double y, + double s,double r, double z); + FitsProjection(const wxString& t, double a,double d, double x, double y, + double cd11, double cd12, double cd21, double cd22); + void ad2xy(double,double,double&,double&); void xy2ad(double,double,double&,double&); void gnomon(double,double,double&,double&); void ignomon(double,double,double&,double&); private: - + wxString type; - double acen, dcen, xcen, ycen, scale, angle; + double acen, dcen, xcen, ycen, scale, angle, reflex; }; @@ -983,7 +992,7 @@ void SetType(int); void SetType(const wxString&); coords_type GetType() const; - + void GetEq(int,int,double&,double&); void RaSix(double,int&,int&,double&); void DecSix(double,char&,int&,int&,double&); @@ -1014,7 +1023,7 @@ { public: PhotoFilter(): flux0(-1.0), leff(0.0), lwidth(0.0) {} - PhotoFilter(const wxString& n,double f0, double le, double lw): + PhotoFilter(const wxString& n,double f0, double le, double lw): name(n),flux0(f0),leff(le),lwidth(lw) {} bool IsOk() const { return flux0 > 0.0; } @@ -1057,9 +1066,9 @@ public: - PhotoConv() {} + PhotoConv() {} PhotoConv(const PhotoFilter&, double, double, double, double); - + double GetFlux(double) const; double GetFnu(double) const; double GetFlam(double) const; @@ -1067,7 +1076,7 @@ double GetMag(double) const; double GetABMag(double) const; double GetSTMag(double) const; - + }; @@ -1075,7 +1084,7 @@ { public: FitsValue(); - FitsValue(const FitsArray&, const wxString&, const wxString&, const wxString&, + FitsValue(const FitsArray&, const wxString&, const wxString&, const wxString&, const wxString&, const wxString&); FitsValue(const FitsArray&,const FitsArray&,const FitsArray&); @@ -1088,12 +1097,12 @@ wxString Get_str(int,int) const; static wxString Label_str(int); - static wxArrayString Label_str(); + static wxArrayString Label_str(); bool HasCal() const { return hascal; } private: - + units_type type; bool hascal; std::vector arrays; @@ -1113,14 +1122,14 @@ class FitsTime { public: - FitsTime():year(0), month(0), day(0), hour(0), minute(0), second(0), + FitsTime():year(0), month(0), day(0), hour(0), minute(0), second(0), milisecond(0) {} FitsTime(const wxString& ); - + void SetDateTime(const wxString& ); void SetDate(const wxString& ); void SetTime(const wxString& ); - + double Jd() const; wxString Date() const { return date; } wxString Time() const { return time; } diff -Nru munipack-0.5.9/xmunipack/Makefile.in munipack-0.5.10/xmunipack/Makefile.in --- munipack-0.5.9/xmunipack/Makefile.in 2017-07-17 23:04:25.000000000 +0000 +++ munipack-0.5.10/xmunipack/Makefile.in 2018-01-16 17:58:16.000000000 +0000 @@ -333,7 +333,6 @@ builddir = @builddir@ datadir = @datadir@ datarootdir = @datarootdir@ -develop = @develop@ docdir = @docdir@ dvidir = @dvidir@ exec_prefix = @exec_prefix@ diff -Nru munipack-0.5.9/xmunipack/view.cpp munipack-0.5.10/xmunipack/view.cpp --- munipack-0.5.9/xmunipack/view.cpp 2017-07-17 23:03:48.000000000 +0000 +++ munipack-0.5.10/xmunipack/view.cpp 2018-01-16 17:58:04.000000000 +0000 @@ -1,9 +1,9 @@ /* - xmunipack - FITS view + xmunipack - FITS view - Copyright © 2009 - 2014 F.Hroch (hroch@physics.muni.cz) + Copyright © 2009 - 2014, 2017 F.Hroch (hroch@physics.muni.cz) This file is part of Munipack. @@ -11,12 +11,12 @@ it under the terms of the GNU General Public License as published by the Free Software Foundation, either version 3 of the License, or (at your option) any later version. - + Munipack is distributed in the hope that it will be useful, but WITHOUT ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the GNU General Public License for more details. - + You should have received a copy of the GNU General Public License along with Munipack. If not, see . @@ -127,14 +127,14 @@ return wxTreeCtrl::Create(parent,wxID_ANY,wxDefaultPosition,wxDefaultSize, (wxTR_DEFAULT_STYLE | wxTR_HAS_BUTTONS | wxTR_HIDE_ROOT | wxTR_FULL_ROW_HIGHLIGHT) & ~wxTR_NO_LINES); - + } - + // Return pointer to the created control virtual wxWindow *GetControl() { return this; } - + virtual wxSize GetAdjustedSize( int minWidth, int WXUNUSED(prefHeight), int maxHeight ) @@ -194,8 +194,8 @@ { int resFlags; wxTreeItemId itemHere = HitTest(event.GetPosition(),resFlags); - if ( itemHere.IsOk() && - ((resFlags & wxTREE_HITTEST_ONITEMLABEL) || + if ( itemHere.IsOk() && + ((resFlags & wxTREE_HITTEST_ONITEMLABEL) || (resFlags & wxTREE_HITTEST_ONITEMICON) || (resFlags & wxTREE_HITTEST_ONITEMSTATEICON) || (resFlags & wxTREE_HITTEST_ONITEMBUTTON) || @@ -213,7 +213,7 @@ { int resFlags; wxTreeItemId itemHere = HitTest(event.GetPosition(),resFlags); - if ( itemHere.IsOk() && + if ( itemHere.IsOk() && ((resFlags & wxTREE_HITTEST_ONITEMLABEL) || (resFlags & wxTREE_HITTEST_ONITEMICON) || (resFlags & wxTREE_HITTEST_ONITEMSTATEICON) || @@ -229,7 +229,7 @@ if( item.IsOk() ) { xTreeItemData *data = dynamic_cast(GetItemData(item)); wxASSERT(data); - + MuniHduEvent ev(EVT_HDU); ev.hdu = data->index; wxQueueEvent(GetGrandParent(),ev.Clone()); @@ -263,7 +263,7 @@ public: void SetMeta(const FitsMeta& meta) { - + DeleteAllItems(); wxFont fn(*wxNORMAL_FONT); @@ -275,7 +275,7 @@ } icons->Add(wxBitmap(MuniIcon::ListIcon(meta.GetIcon(),ssize))); AssignImageList(icons); - + wxTreeItemId root = AddRoot(""); wxTreeItemId hub = AppendItem(root,meta.GetName(),meta.HduCount(),-1,new xTreeItemData(-1)); @@ -294,11 +294,11 @@ wxTreeItemIdValue cookie; wxTreeItemId hub = GetFirstChild(root,cookie); while ( hub.IsOk() ) { - + xTreeItemData *data = dynamic_cast(GetItemData(hub)); wxASSERT(data); if( data->index == hdu ) { - SelectItem(hub); + SelectItem(hub); return; } else { @@ -313,7 +313,7 @@ SelectItem(child); return; } - + child = GetNextChild(hub,cookies); } } @@ -338,7 +338,7 @@ // menus menuFile = new wxMenu; menuFile->Append(wxID_NEW); - + // menuFile->Append(ID_NEW_VIEW, _("&New View...")); // menuFile->Append(ID_NEW_BROWSER,_("&New Browser...")); menuFile->Append(wxID_OPEN); @@ -501,7 +501,7 @@ return; } } - + // if( event.CanVeto() && /*fits.IsModified()*/ IsModified() ) { // wxMessageDialog dialog(this,"Do you really want to leave this window ?", @@ -519,9 +519,9 @@ // if( display->IsRendering() ) MuniDisplay *display = dynamic_cast(place); - if( display ) + if( display ) display->StopRendering(); - + // if( ! backup.IsEmpty() ) { // wxBusyCursor wait; @@ -568,7 +568,7 @@ if( !twin || twin->IsFullScreen()) return; MuniDisplay *display = dynamic_cast(place); - if( display ) + if( display ) event.Check(display->GetFit()); } @@ -578,7 +578,7 @@ if( !twin || twin->IsFullScreen()) return; MuniDisplay *display = dynamic_cast(place); - if( display ) + if( display ) event.Enable(!display->GetFit()); } @@ -617,12 +617,12 @@ { // wxASSERT(backup.IsEmpty()); // RemoveBackup(); - + if( IsModified() ) { if( Unsaved(fits.GetName()) == wxID_CANCEL ) return; } - + // backup.Clear(); meta = FitsMeta(); LoadStart(filename); @@ -723,7 +723,7 @@ config->icon_size); meta = FitsMeta(fits,micon.GetIcon(),micon.GetList()); SetMeta(meta); - } + } wxASSERT(meta.IsOk()); wxASSERT(fits.HduCount() > 0); @@ -813,7 +813,7 @@ viewid.push_back(id); } - + menuWin->AppendSeparator(); menuWin->Append(wxID_BACKWARD,"Previous\tAlt+Left"); @@ -849,7 +849,7 @@ // double xmin,xmax; // bool color = fits.Type() == FITS_COLOR; - + // if( color ) { // /* @@ -878,7 +878,7 @@ // // convrt to XYZ, Luv // // hits = FitsHisto( // hist = FitsHisto(fits.Hdu(2),xmin,xmax); -// } +// } // else if( fits.Type() == FITS_GRAY ) { // FitsArrayStat array(fits.Hdu(0)); // xmin = array.Med() - 5.0*array.Mad(); @@ -919,7 +919,7 @@ void MuniView::FileOpen(wxCommandEvent& WXUNUSED(event)) { if( IsModified() ) { - if( Unsaved(fits.GetName()) == wxID_CANCEL ) + if( Unsaved(fits.GetName()) == wxID_CANCEL ) return; } @@ -1027,7 +1027,7 @@ for(int i = 0; i < table.Width(); i++) cout << " " << table.Pixel_str(i,j) ; cout << endl; - // if( j % 100 == 0) dialog.Pulse(); + // if( j % 100 == 0) dialog.Pulse(); } } } @@ -1052,7 +1052,7 @@ wxFileOutputStream output(select.GetPath()); wxTextOutputStream cout(output); - + const FitsHdu head = fits.Hdu(hdusel); for(size_t i = 0; i < head.GetCount(); i++) cout << head.Item(i) << endl; @@ -1061,7 +1061,7 @@ else wxFAIL_MSG("----- WARNING: Unreachable code."); - + } /* @@ -1129,12 +1129,12 @@ double zoom = 1.0; - wxString entry; + wxString entry; switch(event.GetId()) { case wxID_ZOOM_FIT: zoom = -1.0; break; case wxID_ZOOM_100: zoom = 1.0; break; } - + MuniTuneEvent ev(EVT_TUNE,ID_ZOOM_SCALE); ev.x = zoom; if( event.GetId() == wxID_ZOOM_FIT ) @@ -1146,11 +1146,11 @@ } void MuniView::OnMenuItt(wxCommandEvent& event) -{ +{ wxMenu *menuTune = GetMenuBar()->GetMenu(GetMenuBar()->FindMenu(MENU_TUNE)); wxMenuItem *item = menuTune->FindItem(menuTune->FindItem(TONE_CURVES)); wxMenu *menuProfile= item->GetSubMenu(); - wxASSERT(place && menuTune && menuProfile && + wxASSERT(place && menuTune && menuProfile && menuProfile->FindItem(event.GetId())); MuniTuneEvent ev(EVT_TUNE,ID_ITT_TYPE); @@ -1160,7 +1160,7 @@ } void MuniView::OnCycleItt(wxCommandEvent& event) -{ +{ wxMenu *menuTune = GetMenuBar()->GetMenu(GetMenuBar()->FindMenu(MENU_TUNE)); wxMenuItem *item = menuTune->FindItem(menuTune->FindItem(TONE_CURVES)); wxMenu *menuProfile= item->GetSubMenu(); @@ -1189,11 +1189,11 @@ } void MuniView::OnMenuPal(wxCommandEvent& event) -{ +{ wxMenu *menuTune = GetMenuBar()->GetMenu(GetMenuBar()->FindMenu(MENU_TUNE)); wxMenuItem *item = menuTune->FindItem(menuTune->FindItem(COLOR_PALETTES)); wxMenu *menuPalette= item->GetSubMenu(); - wxASSERT(place && menuTune && menuPalette && + wxASSERT(place && menuTune && menuPalette && menuPalette->FindItem(event.GetId())); MuniTuneEvent ev(EVT_TUNE,ID_PALETTE_TYPE); @@ -1203,7 +1203,7 @@ } void MuniView::OnCyclePal(wxCommandEvent& event) -{ +{ wxMenu *menuTune = GetMenuBar()->GetMenu(GetMenuBar()->FindMenu(MENU_TUNE)); wxMenuItem *item = menuTune->FindItem(menuTune->FindItem(COLOR_PALETTES)); wxMenu *menuPalette= item->GetSubMenu(); @@ -1224,7 +1224,7 @@ } wxASSERT(!label.IsEmpty() ); - menuPalette->Check(itemid,true); + menuPalette->Check(itemid,true); MuniTuneEvent ev(EVT_TUNE,ID_PALETTE_TYPE); ev.SetString(label); @@ -1232,7 +1232,7 @@ } void MuniView::OnMenuNegative(wxCommandEvent& event) -{ +{ wxASSERT(place); MuniTuneEvent ev(EVT_TUNE,ID_PALETTE_NEGATIVE); @@ -1247,7 +1247,7 @@ wxMenu *menuTune = GetMenuBar()->GetMenu(GetMenuBar()->FindMenu(MENU_TUNE)); wxMenuItem *item = menuTune->FindItem(menuTune->FindItem(COLOR_PALETTES)); wxMenu *menuPalette = 0; - if( item ) + if( item ) menuPalette = item->GetSubMenu(); item = menuTune->FindItem(menuTune->FindItem(TONE_CURVES)); @@ -1258,12 +1258,12 @@ int itemid; switch(event.GetId()) { - case ID_ITT_TYPE: + case ID_ITT_TYPE: itemid = menuProfile->FindItem(event.GetString()); wxASSERT(itemid != wxNOT_FOUND); menuProfile->Check(itemid,true); break; - case ID_PALETTE_TYPE: + case ID_PALETTE_TYPE: if( menuPalette ) { itemid = menuPalette->FindItem(event.GetString()); wxASSERT(itemid != wxNOT_FOUND); @@ -1510,7 +1510,7 @@ if( hdusel >= 0 ) { const FitsMetaHdu hdu = meta.Hdu(hdusel); - + switch(fits.Hdu(hdusel).Type()) { case HDU_IMAGE: CreateDisplay(); break; case HDU_TABLE: CreateGrid(); break; @@ -1580,7 +1580,7 @@ void MuniView::CreateHead() { ReplacePlace(new MuniHead(this,config)); - static_cast(place)->SetHdu(fits.Hdu(hdusel)); + static_cast(place)->SetHdu(fits.Hdu(hdusel)); GetToolBar()->EnableTool(wxID_HOME,true); GetToolBar()->EnableTool(ID_INFO,true); @@ -1636,7 +1636,7 @@ { ReplacePlace(new MuniDisplay(this,config)); static_cast(place)->SetHdu(fits.Hdu(hdusel), - meta.Hdu(hdusel).GetIcon()); + meta.Hdu(hdusel).GetIcon()); // menus menuView->AppendCheckItem(ID_DETAIL,"Detail Panel"); @@ -1717,7 +1717,7 @@ // toolbar MuniArtIcons ico(wxART_TOOLBAR,wxSize(22,22)); - + wxToolBar *tbar = GetToolBar(); wxASSERT(tbar); @@ -1741,10 +1741,10 @@ if( fits.Hdu(i).GetKey("EXTNAME").Find("MUNIPACK") != wxNOT_FOUND ) { FitsTable t(fits.Hdu(i)); dynamic_cast(place)->SetStars(t); - /* + /* wxMemoryOutputStream ostream; t.GetStarChart(ostream); - + wxMemoryInputStream istream(ostream); dynamic_cast(place)->SetOverlay(istream); */ @@ -1769,8 +1769,8 @@ Bind(EVT_TUNE,&MuniView::OnTuneFine,this); // Bind(EVT_DIALOG,&MuniView::OnPhotometry,this,ID_PHOT); - double xpix, ypix, alpha, delta, scale, angle; - if( fits.Hdu(hdusel).GetWCS(xpix, ypix, alpha, delta, scale, angle) ) { + double xpix, ypix, alpha, delta, scale, angle, reflex; + if( fits.Hdu(hdusel).GetWCS(xpix, ypix, alpha, delta, scale, angle, reflex) ){ menuView->Check(ID_GRID,config->display_grid); wxASSERT(dynamic_cast(place)); dynamic_cast(place)->ShowGrid(config->display_grid); @@ -1869,7 +1869,7 @@ // wxASSERT(place); //Layout(); - // arrange stretch space in toolbar + // arrange stretch space in toolbar // wxSize size(GetSize()); /* @@ -1879,7 +1879,7 @@ // Black Magick. The part of code together with code in display.cpp // setups scrolling for images. I had spend lot of time with looking // for a way how correctly does it. The principle is set size - // of place to minumum while deriving virtual size by image. + // of place to minumum while deriving virtual size by image. // wxPostEvent(place,event); @@ -1947,7 +1947,7 @@ // void MuniView::RunShell(const queue& com) // { -// // wxBeginBusyCursor(); // must be called out of exec and write to +// // wxBeginBusyCursor(); // must be called out of exec and write to // shell = new MuniShell(GetEventHandler(),com); @@ -1958,7 +1958,7 @@ // archiveprop->SetLabel(_("Files are being processed.")); // SetArchiveSize(); // */ -// } +// } // void MuniView::OnShell(MuniShellEvent& event) // { @@ -1981,7 +1981,7 @@ // console->AppendError(event.err); // */ -// wxArrayString results = event.res; +// wxArrayString results = event.res; // for(size_t i = 0; i < results.GetCount(); i++) { // wxLogDebug(results[i]); // LoadFile(results[i]); diff -Nru munipack-0.5.9/xmunipack/xmunipack.1 munipack-0.5.10/xmunipack/xmunipack.1 --- munipack-0.5.9/xmunipack/xmunipack.1 2017-07-17 23:03:48.000000000 +0000 +++ munipack-0.5.10/xmunipack/xmunipack.1 2018-01-16 17:58:04.000000000 +0000 @@ -3,7 +3,7 @@ .SH NAME xmunipack \- graphical user interface for Munipack .SH SYNOPSIS -.B xmunipack +.B xmunipack .I [fits] .SH DESCRIPTION Munipack is a general astronomical image processing software. @@ -22,14 +22,10 @@ .SH AUTHOR Written by Filip Hroch. .SH COPYRIGHT -Copyright © 2009-2016 Filip Hroch . +Copyright © 2009-2018 Filip Hroch . License GPLv3+: GNU GPL version 3 or later This is free software: you are free to change and redistribute it. There is NO WARRANTY, to the extent permitted by law. .SH SEE ALSO -munipack(1), http://munipack.physics.muni.cz/, -.PP -file:///opt/munipack/share/doc/munipack/html/ -.PP -file:///usr/local/share/doc/html/munipack/html/ +munipack(1), http://munipack.physics.muni.cz/, /usr/share/doc/munipack diff -Nru munipack-0.5.9/xmunipack/xmunipack.cpp munipack-0.5.10/xmunipack/xmunipack.cpp --- munipack-0.5.9/xmunipack/xmunipack.cpp 2017-07-17 23:03:48.000000000 +0000 +++ munipack-0.5.10/xmunipack/xmunipack.cpp 2018-01-16 17:58:04.000000000 +0000 @@ -10,12 +10,12 @@ it under the terms of the GNU General Public License as published by the Free Software Foundation, either version 3 of the License, or (at your option) any later version. - + Munipack is distributed in the hope that it will be useful, but WITHOUT ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the GNU General Public License for more details. - + You should have received a copy of the GNU General Public License along with Munipack. If not, see . @@ -52,7 +52,7 @@ OnInitCmdLine(cmd); cmd.AddSwitch("","version","print version and license"); cmd.AddParam("filename",wxCMD_LINE_VAL_STRING,wxCMD_LINE_PARAM_OPTIONAL); - + if( cmd.Parse() == 0 ) { if( cmd.Found("verbose") ) @@ -79,7 +79,7 @@ // initialisation wxHandleFatalExceptions(); - wxInitAllImageHandlers(); + wxInitAllImageHandlers(); config = new MuniConfig(); #ifdef __WXMAC__ @@ -134,7 +134,7 @@ ftp.SetPassword(FTP_PASSWORD); if ( !ftp.Connect(FTP_SERVER) ) { - wxLogError("Couldn't send bug report: Failed to connect.\n" + wxLogError("Couldn't send bug report: Failed to connect.\n" "Leaving files in "+report.GetDirectory()+".\n"); report.Reset(); return; @@ -155,4 +155,3 @@ } } - diff -Nru munipack-0.5.9/xmunipack/xmunipack.h munipack-0.5.10/xmunipack/xmunipack.h --- munipack-0.5.9/xmunipack/xmunipack.h 2017-07-17 23:03:48.000000000 +0000 +++ munipack-0.5.10/xmunipack/xmunipack.h 2018-01-16 17:58:04.000000000 +0000 @@ -3,7 +3,7 @@ XMunipack - Copyright © 2009-2015 F.Hroch (hroch@physics.muni.cz) + Copyright © 2009-2015, 2017 F.Hroch (hroch@physics.muni.cz) This file is part of Munipack. @@ -11,12 +11,12 @@ it under the terms of the GNU General Public License as published by the Free Software Foundation, either version 3 of the License, or (at your option) any later version. - + Munipack is distributed in the hope that it will be useful, but WITHOUT ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the GNU General Public License for more details. - + You should have received a copy of the GNU General Public License along with Munipack. If not, see . @@ -172,7 +172,7 @@ { public: MuniFileProperties(wxWindow *w, const FitsMeta& , const MuniConfig *); - + private: FitsMeta meta; @@ -205,7 +205,7 @@ class MuniConsole: public wxFrame { -public: +public: MuniConsole(wxWindow *, MuniConfig *); virtual ~MuniConsole(); void AppendOutput(const wxArrayString&); @@ -246,18 +246,18 @@ class MuniLog: public wxLogWindow { -public: +public: MuniLog(wxWindow *); virtual ~MuniLog(); - + virtual bool OnFrameClose(wxFrame *); bool Visibility(); - + private: wxWindow *topwin; bool visible; - + }; class MuniAbout @@ -272,9 +272,9 @@ public: MuniHelp(MuniConfig *); virtual ~MuniHelp(); - + private: - + wxHtmlWindow *web; wxString home; wxTextCtrl *turl; @@ -303,7 +303,7 @@ DECLARE_EVENT_TABLE() }; - + // class MuniGraph: public wxPanel // { // public: @@ -335,7 +335,7 @@ // { // public: // MuniStrip(wxWindow *, const wxSize&, const FitsItt&, const FitsPalette&); - + // void SetItt(const FitsItt&); // void SetPalette(const FitsPalette&); @@ -381,7 +381,7 @@ // virtual ~MuniThumbCanvas() {} void SetIcon(const wxBitmap&); void SetIcon(const wxImage&); - + private: wxBitmap icon; @@ -403,7 +403,7 @@ protected: MuniConfig *config; - MuniPipe pipe; + MuniPipe pipe; wxTimer timer; bool running, readonly; int exitcode; @@ -425,7 +425,7 @@ void DrawObjects(const std::vector&,const std::vector&,const std::vector&); private: - + const wxColour gold,DarkOrange2; std::vector objects; @@ -573,7 +573,7 @@ void OnMatchType(wxCommandEvent&); void OnFullMatch(wxCommandEvent&); void OnChoiceUnits(wxCommandEvent&); - + }; class MuniAstrometry: public wxDialog @@ -593,7 +593,7 @@ wxGauge *progress; wxStaticText *overlayid, *refcatid, *info, *infolabel, *proginfo, *proglabel; wxBoxSizer *autosizer; - wxCheckBox *overlay_check; + wxCheckBox *overlay_check, *reflex_checkbox; FitsArray array; FitsTable catalogue, stars, coverlay; wxTimer timer; @@ -603,7 +603,7 @@ int nstars,nhist; double maglim, s0, rms; - double xoff,yoff,alpha, delta, scale, angle, amin, dmin, fmin; + double xoff,yoff,alpha, delta, scale, reflex, angle, amin, dmin, fmin; wxString proj,label_ra,label_dec,label_mag, label_pmra, label_pmdec; bool init_par, init_file, init_ref, running, parsing, unsaved, draw_overlay, edited, relative, tmpcat,readonly,showtooltip; @@ -620,6 +620,7 @@ void OnCalibrateStop(wxCommandEvent&); void OnCalibrateFinish(wxProcessEvent&); void OnOverlay(wxCommandEvent&); + void OnReflex(wxCommandEvent&); void OnDrawOverlay(wxCommandEvent&); void OnReference(wxCommandEvent&); void OnTimer(wxTimerEvent&); @@ -652,7 +653,7 @@ class MuniAstrolog { wxDateTime datetime; - + public: MuniAstrolog(); MuniAstrolog(const wxDateTime&); @@ -694,7 +695,7 @@ void ParseOutput(); void OnProcess(wxCommandEvent&); void OnTimer(wxTimerEvent&); - void OnFinish(wxProcessEvent&); + void OnFinish(wxProcessEvent&); void OnReference(wxCommandEvent&); void OnChoiceProj(wxCommandEvent&); void EraseTemp(); @@ -1057,7 +1058,7 @@ wxString GetFullPath(const wxString& =wxEmptyString) const; wxString DissolveRoot(const wxString&) const; long NextAvailableIndex() const; - wxArrayString GetItems(const wxString&, int, + wxArrayString GetItems(const wxString&, int, const wxString& =wxEmptyString) const; bool IsAbsPath(const wxString&) const; void OnMetaOpen(MetaOpenEvent&); @@ -1107,7 +1108,7 @@ virtual ~MetaRender(); protected: - + wxEvtHandler *handler; MuniConfig *config; @@ -1246,7 +1247,7 @@ { public: MuniListWindow(wxWindow *, wxWindowID, long = 0, MuniConfig * = 0); - + void AddWindow(wxWindow *); void SetStyle(long); @@ -1409,8 +1410,8 @@ class MuniBrowserSearch: public wxSearchCtrl { public: - MuniBrowserSearch(wxWindow *, wxWindowID, const wxString& =wxEmptyString, - const wxPoint& =wxDefaultPosition, + MuniBrowserSearch(wxWindow *, wxWindowID, const wxString& =wxEmptyString, + const wxPoint& =wxDefaultPosition, const wxSize& =wxDefaultSize, long =0); std::vector Find(const std::vector&) const; @@ -1553,7 +1554,7 @@ void OnUpdateTbot(wxUpdateUIEvent&); void OnUpdateCut(wxUpdateUIEvent&); void OnUpdatePaste(wxUpdateUIEvent&); - + }; @@ -1562,8 +1563,7 @@ bool OnInit(); int OnExit(); void OnFatalException(); - + MuniConfig *config; }; -