77 use sufr_kinds,
only: double
78 use sufr_date_and_time,
only: cal2jd
79 use sufr_solvers,
only: minimum_solver
85 real(double),
intent(in) :: jdin
86 integer,
intent(in) :: plID
87 real(double),
intent(out) :: jdout
88 real(double),
intent(out),
optional :: xsmag
89 logical,
intent(in),
optional :: rsCWarn
92 real(double) :: tz, jd1,jd2, plvis(2), lxsmag
96 if(
present(rscwarn)) lrscwarn = rscwarn
101 jd1 = floor(jdin+0.5d0) - 0.5d0 + (plvis(1)-tz)/24.d0
102 jd2 = floor(jdin+0.5d0) - 0.5d0 + (plvis(2)-tz)/24.d0
103 if(plvis(1).gt.12.d0) jd1 = jd1 - 1.d0
104 if(plvis(2).gt.12.d0) jd2 = jd2 - 1.d0
107 lxsmag = minimum_solver(
pl_xsmag_pl, jd1, (jd1+jd2)/2.d0, jd2, 1.d-3, jdout, status=status)
109 if(
present(xsmag)) xsmag = lxsmag
126 use sufr_kinds,
only: double
127 use sufr_constants,
only: r2d
128 use sufr_date_and_time,
only: jd2cal,cal2jd
129 use sufr_angles,
only: rv12
137 real(double),
intent(in) :: jd
138 integer,
intent(in) :: pl
142 real(double) :: srt,stt,sst,srh,sta,ssh, mrt,mtt,mst,mrh,mta,msh, sundat(
nplanpos)
147 call riset(jd,pl, mrt,mtt,mst, mrh,mta,msh, 0.d0)
150 call jd2cal(jd,yr,mn,dy)
151 dy = floor(dy) + (mtt-
tz)/24.d0
152 jd1 = cal2jd(yr,mn,dy)
157 if(sundat(30)*r2d.lt.sun_maxalt)
then
166 smaxalt = 2*sun_maxalt
168 do while(smaxalt.lt.-0.25d0)
169 smaxalt = smaxalt/2.d0
170 call riset(jd,3, srt,stt,sst, srh,sta,ssh, smaxalt)
172 if(abs(rv12(mtt-sst)).lt.abs(rv12(mtt-srt)))
then
173 dy = floor(dy) + (sst-
tz)/24.d0
175 dy = floor(dy) + (srt-
tz)/24.d0
178 jd1 = cal2jd(yr,mn,dy)
180 if(
planpos(30)*r2d.gt.-smaxalt/2.d0)
exit
215 subroutine planet_visibility_tonight(jd, pl, sunAlt, plalt, comp, plvis, plazs, rts, tts, sts, ras, tas, sas, rsCWarn)
216 use sufr_kinds,
only: double
217 use sufr_constants,
only: r2d
218 use sufr_numerics,
only: deq, deq0
219 use sufr_angles,
only: rv12
220 use sufr_sorting,
only: sorted_index_list
225 real(double),
intent(in) :: jd, sunAlt, plalt
226 integer,
intent(in) :: pl, comp
227 real(double),
intent(out) :: plvis(2)
228 real(double),
intent(out),
optional :: plazs(2), rts(5), tts(5), sts(5), ras(5), tas(5), sas(5)
229 logical,
intent(in),
optional :: rsCWarn
231 integer :: irs, ix, maxi, ind(4), oldComp, firstCall
232 real(double) :: alt, times(4),azs(4), lrts(5), ltts(5), lsts(5), lras(5),ltas(5),lsas(5)
233 real(double) :: oldJD, oldSunAlt, oldSunData(6,2)
234 logical :: sup,pup,pvis,pvisold, lrsCWarn
236 save firstcall, oldcomp, oldjd, oldsunalt, oldsundata
238 lrts=0.d0; ltts=0.d0; lsts=0.d0; lras=0.d0;ltas=0.d0;lsas=0.d0; plvis=0.d0
239 if(
present(plazs)) plazs=0.d0
242 if(
present(rscwarn)) lrscwarn = rscwarn
248 if(comp.eq.2.or.comp.eq.12) maxi = 2
252 if( firstcall.eq.12345 .and. comp.eq.oldcomp .and. deq(jd,oldjd) .and. deq(sunalt,oldsunalt))
then
254 lrts(irs) = oldsundata(1, irs)
255 ltts(irs) = oldsundata(2, irs)
256 lsts(irs) = oldsundata(3, irs)
257 lras(irs) = oldsundata(4, irs)
258 ltas(irs) = oldsundata(5, irs)
259 lsas(irs) = oldsundata(6, irs)
261 if(irs.eq.2) alt = 0.d0
264 call riset(jd, 3, lrts(irs), ltts(irs), lsts(irs), lras(irs), ltas(irs), lsas(irs), alt, for_night=.true., cwarn=lrscwarn)
265 oldsundata(1:6, irs) = [lrts(irs), ltts(irs), lsts(irs), lras(irs), ltas(irs), lsas(irs)]
279 if(comp.eq.2.or.comp.eq.12) maxi = 5
282 if(irs.eq.5) alt = 0.d0
285 call riset(jd, pl, lrts(irs), ltts(irs), lsts(irs), lras(irs), ltas(irs), lsas(irs), alt, for_night=.true., cwarn=lrscwarn)
288 if(deq0(lrts(irs))) lrts(irs) = -12.d0
290 if(deq0(lsts(irs))) lsts(irs) = 12.d0
299 times = [rv12(lrts(1)), rv12(lsts(1)), rv12(lrts(4)), rv12(lsts(4))]
300 azs = [lras(1), lsas(1), lras(4), lsas(4)]
301 call sorted_index_list(times,ind)
304 if(ind(1).eq.2.and.ind(2).eq.4.and.ind(3).eq.3.and.ind(4).eq.1 .and. times(4)-times(2).gt.times(1)-times(3))
then
308 if(times(2)-times(1) .lt. 1.d0) times = [times(2),times(2), times(2),times(1)]
317 if(pl.gt.9.and.abs(lrts(4)*lsts(4)).lt.1.d-20)
then
318 if(ltas(4)*r2d.gt.plalt)
then
319 plvis(1) = rv12(lsts(1))
320 plvis(2) = rv12(lrts(1))
322 if(
present(plazs))
then
328 if(
present(plazs)) plazs = 0.d0
333 if(rv12(lrts(4)).ge.0.d0 .and. rv12(lrts(4)).gt.rv12(lsts(4))) pup = .true.
335 pvis = pup.and..not.sup
349 pvis = pup.and..not.sup
351 if(pvis.and..not.pvisold)
then
352 plvis(1) = times(ind(ix))
353 if(
present(plazs)) plazs(1) = azs(ind(ix))
355 if(.not.pvis.and.pvisold)
then
356 plvis(2) = times(ind(ix))
357 if(
present(plazs)) plazs(2) = azs(ind(ix))
364 if(
present(rts)) rts = lrts
365 if(
present(tts)) tts = ltts
366 if(
present(sts)) sts = lsts
368 if(
present(ras)) ras = lsas
369 if(
present(tas)) tas = ltas
370 if(
present(sas)) sas = lras
215 subroutine planet_visibility_tonight(jd, pl, sunAlt, plalt, comp, plvis, plazs, rts, tts, sts, ras, tas, sas, rsCWarn)
…
392 use sufr_kinds,
only: double
393 use sufr_constants,
only: r2d, jd2000
401 real(double),
intent(in) :: jd, mlim, minalt
402 integer,
intent(in) :: cometid
403 real(double) :: tjm, hcr,gcl,gcb,delta, magn, eps, ra,dec, maxalt
408 tjm = (jd-jd2000)/365250.d0
409 call cometgc(tjm,tjm, cometid, hcr,gcl,gcb,delta)
417 if(magn.gt.mlim)
then
442 use sufr_kinds,
only: double
444 real(double),
intent(in) :: lat, dec
447 transitalt = asin(sin(lat)*sin(dec) + cos(lat)*cos(dec))
463 use sufr_kinds,
only: double
464 use sufr_constants,
only: pi
465 use sufr_date_and_time,
only: doy2md, cal2jd, jd2cal
466 use sufr_solvers,
only: root_solver
469 integer,
intent(in) :: year,accuracy
470 real(double),
intent(in) :: RA
471 integer,
intent(out) :: mon,dy
473 integer :: yr,best_obs_doy0,doy1
474 real(double) :: jd0,lRA,dRA,djd,jd1,dy1
476 common /best_obs_ra/ dra,lra
483 doy1 = mod(nint(lra/0.017202791805d0) + best_obs_doy0 + 10*366,366)
484 call doy2md(doy1, yr,mon,dy)
486 if(accuracy.ge.1)
then
487 jd0 = cal2jd(yr,mon,dble(dy))
490 jd1 = root_solver(
get_dra_obj, jd0-djd,jd0+djd, 1.d-1)
491 call jd2cal(jd1,yr,mon,dy1)
508 use sufr_kinds,
only: double
509 use sufr_angles,
only: rev2
515 real(double),
intent(in) :: jd
517 common /best_obs_ra/ dra,ra
540 use sufr_kinds,
only: double
541 use sufr_constants,
only: am2r
544 real(double),
intent(in) :: alt
545 real(double) ::
airmass,sinh,sinh2
547 if(alt.lt.-34*am2r)
then
548 airmass = 1000.d0 * (0.15d0 + abs(alt))
553 airmass = (1.002432d0*sinh2 + 0.148386d0*sinh + 0.0096467d0) / &
554 (sinh2*sinh + 0.149864d0*sinh2 + 0.0102963d0*sinh + 0.000303978d0)
574 use sufr_kinds,
only: double
575 use sufr_constants,
only: pio2, r2d
578 real(double),
intent(in) :: alt
585 z = min(pio2 - alt, pio2)
587 airmass_la = max( 1.d0 / ( cos(z) + 0.50572d0*(96.07995d0-zdeg)**(-1.6364d0) ) , 1.d0 )
611 use sufr_kinds,
only: double
614 real(double),
intent(in) :: ele
618 aray = 0.1451d0 * exp(-ele/7996.d0)
619 aaer = 0.120d0 * exp(-ele/1500.d0)
641 use sufr_kinds,
only: double
644 real(double),
intent(in) :: alt
645 real(double),
intent(in),
optional :: ele
649 if(
present(ele)) elel = ele
672 use sufr_kinds,
only: double
675 real(double),
intent(in) :: alt
676 real(double),
intent(in),
optional :: ele
680 if(
present(ele)) elel = ele
717 function limmag_full(year,month, obsElev,obsLat, sunAlt,sunElon, moonPhase,moonAlt,moonElon, objAlt, humid,airTemp,snrat, verbosity)
718 use sufr_kinds,
only: double
721 integer,
intent(in) :: year, month
722 real(double),
intent(in) :: obselev,obslat, sunalt,sunelon, moonphase,moonalt,moonelon, objalt
723 integer,
intent(in),
optional :: verbosity
724 real(double),
intent(in),
optional :: humid,airtemp,snrat
727 real(double) ::
limmag_full, skybr(5),extcoef(5),extmag(5), relhum,temp,sn, c1,c2,th
729 if(objalt.lt.0.d0)
then
737 if(
present(humid)) relhum = humid
740 if(
present(airtemp)) temp = airtemp
743 if(
present(snrat)) sn = snrat
746 if(
present(verbosity)) verb = verbosity
749 call limmag_extinction(month, obslat,obselev, objalt, relhum,temp, 3,3, extcoef, extmag)
750 call limmag_skybrightness(year, sunalt,sunelon, moonphase,moonalt,moonelon, objalt, 3,3, extcoef, skybr)
756 if(skybr(3).lt.1500.d0)
then
760 c1 = 10.d0**(-8.35d0)
763 th = c1*(1.d0 + sqrt(c2*skybr(3)))**2
765 limmag_full = -16.57d0 - 2.5d0*log10(th) - extmag(3) + 5*log10(sn)
768 write(*,
'(A,F12.5)')
'Extinction coefficient (V band): ', extcoef(3)
769 write(*,
'(A,F12.5)')
'Extinction in V magnitudes: ', extmag(3)
770 write(*,
'(A,ES12.5)')
'Sky surface brightness (V) in erg/s/cm^2/μ/arcsec^2: ', skybr(3)*1.02d-15
771 write(*,
'(A,F12.5)')
'Sky surface brightness (V) in nL: ', skybr(3)
772 write(*,
'(A,ES12.5)')
'Sky brightness (V) in foot candles: ', th
773 write(*,
'(A,F12.5)')
'V magnitude limit: ',
limmag_full
717 function limmag_full(year,month, obsElev,obsLat, sunAlt,sunElon, moonPhase,moonAlt,moonElon, objAlt, humid,airTemp,snrat, verbosity)
…
802 subroutine limmag_extinction(month, obsLat,obsElev, objAlt, relHum,temp, band1,band2, extCoef,extMag)
803 use sufr_kinds,
only: double
804 use sufr_constants,
only: d2r, earthr
807 integer,
intent(in) :: month, band1,band2
808 real(double),
intent(in) :: obsLat, objAlt, obsElev, relHum, temp
809 real(double),
intent(out) :: extCoef(5),extMag(5)
811 integer :: iBand, band1l,band2l, sl
812 real(double) :: wa(5), oz(5),wt(5), ra,xg,xa,xo,kr,ka,ko,kw, Re_km, sinObjAlt
815 band1l = max(1,band1)
816 band2l = min(5,band2)
818 extcoef = 0.d0; extmag = 0.d0
819 wa = [ 0.365d0, 0.44d0, 0.55d0, 0.7d0, 0.9d0 ]
820 oz = [ 0.000d0, 0.000d0, 0.031d0, 0.008d0, 0.000d0 ]
821 wt = [ 0.074d0, 0.045d0, 0.031d0, 0.020d0, 0.015d0 ]
824 ra = (month-3)*30*d2r
825 sl = nint(obslat/abs(obslat+tiny(obslat)))
829 sinobjalt = sin(objalt)
830 xg = 1.d0 / ( sinobjalt + 0.0286d0 * exp(-10.5d0*sinobjalt) )
831 xa = 1.d0 / ( sinobjalt + 0.0123d0 * exp(-24.5d0*sinobjalt) )
832 xo = 1.d0 / sqrt( 1.d0 - (cos(objalt)/(1.d0 + (20.d0/re_km)))**2 )
835 do iband=band1l,band2l
836 kr = 0.1066d0 * exp(-obselev/8200.d0) * (wa(iband)/0.55d0)**(-4)
837 ka = 0.1d0 * (wa(iband)/0.55d0)**(-1.3d0) * exp(-obselev/1500.d0)
838 ka = ka * (1.d0 - 0.32d0/log(relhum/100.d0))**1.33d0 * (1.d0 + 0.33d0 * sl * sin(ra))
839 ko = oz(iband) * (3.d0 + 0.4d0 * (obslat*cos(ra) - cos(3*obslat)) )/3.d0
840 kw = wt(iband) * 0.94d0 * (relhum/100.d0) * exp(temp/15.d0 - obselev/8200.d0)
842 extcoef(iband) = kr + kw + ka + ko
843 extmag(iband) = (kr+kw)*xg + ka*xa + ko*xo
802 subroutine limmag_extinction(month, obsLat,obsElev, objAlt, relHum,temp, band1,band2, extCoef,extMag)
…
873 subroutine limmag_skybrightness(year, sunAlt,sunElon, moonPhase,moonAlt,moonElon, objAlt, band1,band2, extCoef, skyBr)
874 use sufr_kinds,
only: double
875 use sufr_constants,
only: pi,pi2,pio2, r2d
879 integer,
intent(in) :: year, band1,band2
880 real(double),
intent(in),
value :: objAlt, moonAlt,sunAlt, moonPhase,moonElon, sunElon
881 real(double),
intent(in) :: extCoef(5)
882 real(double),
intent(out) :: skyBr(5)
884 integer :: iBand, band1l,band2l
885 real(double) :: mo(5),bo(5),cm(5),ms(5), objAM,moonAM,sunAM,bn, moonPA,mm,c3, moonElonM, fm,bm,bt,c4,fs,bd
888 band1l = max(1, band1)
889 band2l = min(5, band2)
894 mo = [ -10.93d0, -10.45d0, -11.05d0, -11.90d0, -12.70d0 ]
895 bo = [ 8.0d-14, 7.0d-14, 1.0d-13, 1.0d-13, 3.0d-13 ]
896 cm = [ 1.36d0, 0.91d0, 0.00d0, -0.76d0, -1.17d0 ]
897 ms = [ -25.96d0, -26.09d0, -26.74d0, -27.26d0, -27.55d0 ]
900 objam = 1.d0/(sin(objalt) + 0.025d0*exp(-11.d0*sin(objalt)))
903 if(moonalt.lt.0.d0)
then
906 moonam = 1.d0/(sin(moonalt) + 0.025d0*exp(-11.d0*sin(moonalt)))
910 if(sunalt.lt.0.d0)
then
913 sunam = 1.d0/(sin(sunalt) + 0.025d0*exp(-11.d0*sin(sunalt)))
918 do iband=band1l,band2l
921 bn = bo(iband) * (1.d0 + 0.3d0*cos(pi2*dble(year-1992)/11.d0))
922 bn = bn * (0.4d0 + 0.6d0/sqrt(1.d0-0.96d0*cos(objalt)**2))
923 bn = bn * 10.d0**(-0.4d0*extcoef(iband)*objam)
926 if(moonalt.ge.0.d0)
then
927 moonpa = (1.d0 - moonphase)*pi
928 mm =
moonmagn(moonpa,2.5696d-3) + cm(iband)
930 c3 = 10.d0**(-0.4d0*extcoef(iband)*moonam)
932 moonelonm = max(moonelon,4.36d-3)
933 fm = 1.888628d4/moonelonm**2 + 10.d0**(6.15d0 - moonelonm/0.6981317d0)
934 fm = fm + 10.d0**5.36d0 * (1.06d0 + cos(moonelonm)**2)
936 bm = 10.d0**( -0.4d0 * (mm - mo(iband) + 43.27d0) )
937 bm = bm * (1.d0 - 10.d0**(-0.4d0*extcoef(iband)*objam))
938 bm = bm * (fm*c3 + 440000.d0*(1.d0-c3))
944 bt = 10.d0**( -0.4d0*(ms(iband) - mo(iband) + 32.5d0 - sunalt*r2d - ((pio2-objalt)/(pi2*extcoef(iband))) ) )
945 bt = bt * (1.745329252d0/sunelon) * (1.d0 - 10.d0**((-0.4d0*extcoef(iband))*objam))
948 c4 = 10.d0**(-0.4d0*extcoef(iband)*sunam)
949 fs = 1.888628d4/sunelon**2 + 10.d0**(6.15d0 - sunelon/0.6981317d0)
950 fs = fs + 10.d0**5.36d0 * (1.06d0 + cos(sunelon)**2)
951 bd = 10.d0**(-0.4d0*(ms(iband) - mo(iband) + 43.27d0))
952 bd = bd * (1.d0 - 10.d0**(-0.4d0*extcoef(iband)*objam))
953 bd = bd * (fs*c4 + 440000.d0*(1.d0-c4))
957 skybr(iband) = bn + bd + bm
959 skybr(iband) = bn + bt + bm
962 skybr(iband) = skybr(iband) / 1.02d-15
873 subroutine limmag_skybrightness(year, sunAlt,sunElon, moonPhase,moonAlt,moonElon, objAlt, band1,band2, extCoef, skyBr)
…
986 use sufr_kinds,
only: double
987 use sufr_angles,
only: asep
988 use sufr_date_and_time,
only: jd2cal
995 real(double),
intent(in),
value :: jd, objra,objdec,objalt
996 real(double),
intent(in),
optional :: lat,
height
998 real(double) ::
limmag_jd, llat,lheight,
day, sunalt,sunelon, moonphase,moonalt,moonelon, planpos0(
nplanpos)
1005 if(
present(lat)) llat = lat
1041 use sufr_kinds,
only: double
1042 use sufr_constants,
only: pio2
1048 real(double),
intent(in) :: jd, lat,lon,height
1054 call horiz2eq(0.d0,objalt, gmst, hh,objra,objdec, lat,lon)
1074 use sufr_kinds,
only: double
1080 real(double),
intent(in) :: jd
1081 integer,
intent(in) :: pl
1116 use sufr_kinds,
only: double
1117 use sufr_constants,
only: d2r
1118 use sufr_angles,
only: asep
1119 use sufr_date_and_time,
only: jd2cal
1124 integer,
intent(in) ::
month
1125 real(double),
intent(in),
value :: sunalt,sunaz, objalt,objaz
1126 real(double),
intent(in),
optional :: lat,
height
1128 real(double) ::
limmag_sun_airmass, llat,lheight, sunelon, moonphase,moonalt,moonelon
1135 if(
present(lat)) llat = lat
1140 sunelon = asep(objaz, sunaz, objalt, sunalt)
1168 use sufr_kinds,
only: double
1169 use sufr_constants,
only: r2d
1172 real(double),
intent(in) :: sunalt
1173 real(double) ::
limmag_sun, dm,bn,bt,bd,bl,c1,c2,th
1175 dm = 0.285667465769191d0
1176 bn = 7.686577723230466d-14
1177 bt = 10.d0**(-0.4d0*(-26.74d0 + 11.05d0 + 32.5d0 - sunalt*r2d )) * 0.12852345982053d0
1178 bd = 9.456022312552874d-7
1179 bl = (bn + min(bd,bt))/1.02d-15
1182 if(bl.lt.1500.d0)
then
1183 c1 = 10.d0**(-9.8d0)
1184 c2 = 10.d0**(-1.9d0)
1186 c1 = 10.d0**(-8.350001d0)
1187 c2 = 10.d0**(-5.9d0)
1189 th = c1*(1.d0 + sqrt(c2*bl))**2
1216 use sufr_kinds,
only: double
1222 real(double),
intent(in) :: jd
1223 integer,
intent(in) :: pl
1224 real(double) ::
pl_xsmag, objra,objdec,objalt
1231 if(objalt.lt.0.d0)
then
1249 use sufr_kinds,
only: double
1253 real(double),
intent(in) :: jd
1277 use sufr_kinds,
only: double
1282 real(double),
intent(in) :: jd
1283 integer,
intent(in) :: pl
1310 use sufr_kinds,
only: double
1314 real(double),
intent(in) :: jd
1342 use sufr_kinds,
only: double
1345 real(double),
intent(in) :: xsmag
1346 real(double),
intent(in),
optional :: pupil, tc
1347 real(double) ::
aperture, lpupil, ltc
1351 if(
present(pupil)) lpupil = pupil
1355 if(
present(tc)) ltc = tc
1357 if(xsmag.le.0.d0)
then
1360 aperture = lpupil * sqrt(10.d0**(xsmag/2.5d0) / ltc) / 10.d0
1378 use sufr_kinds,
only: double
1381 real(double),
intent(in) :: mlim
1384 if(mlim.lt.7.93d0)
then
1404 use sufr_kinds,
only: double
1407 real(double),
intent(in) :: skybright
1427 use sufr_kinds,
only: double
1430 real(double),
intent(in) :: cdm2
1435 mlim = 7.706d0 - 5*log10(1.d0 + 0.1122d0 * sqrt(nl))
1436 if(nl.gt.1479) mlim = 4.115d0 - 5*log10(1.d0 + 0.001122d0 * sqrt(nl))
1452 use sufr_kinds,
only: double
1455 real(double),
intent(in) :: mlim
1458 nl = ((10.d0**(-(mlim - 7.706d0)/5.d0) - 1.d0)/0.1122d0)**2
1459 if(mlim.lt.4) nl = ((10.d0**(-(mlim - 4.115d0)/5.d0) - 1.d0)/0.001122d0)**2
1476 use sufr_kinds,
only: double
1477 use sufr_constants,
only: pi
1480 real(double),
intent(in) :: nl
1495 use sufr_kinds,
only: double
1496 use sufr_constants,
only: pi
1499 real(double),
intent(in) :: cdm2
Data to compute comet positions.
logical, dimension(ncometsmax) cometdiedatp
This comet died at perihelion (true/false)
real(double), dimension(ncometsmax, 9) cometelems
Orbital elements of the comets: 1: JD of epoch (often J2000), 2: Perihelion distance (AU?...
subroutine cometgc(t, t0, comid, r, l, b, d)
Calc geocentric lbr coordinates for comet com at t1 (in Julian millennia Dynamical Time)
Procedures for coordinates.
subroutine horiz2eq(az, alt, agst, hh, ra, dec, lat, lon)
Convert spherical horizontal coordinates (az, alt, agst) to spherical equatorial coordinates (hh,...
subroutine ecl_2_eq(l, b, eps, ra, dec)
Convert (geocentric) spherical ecliptical coordinates l,b (and eps) to spherical equatorial coordinat...
Date and time procedures.
real(double) function calc_gmst(jd, deltat)
Calculate Greenwich Mean Sidereal Time for any instant, in radians.
real(double) function gettz(jd, tz0, dsttp)
Returns time zone: tz0 (standard time) or tz0+1 (daylight-savings time)
Local parameters for libTheSky: location, date, time.
integer month
Month of year of current instant.
real(double) tz
Current value of time zone, taking into account DST (hours; >0 is east of Greenwich)
real(double) height
Altitude of the observer above sea level (m)
real(double) lat0
Latitude of the observer (rad)
real(double) day
Day of month of current instant, with decimals if desired.
integer year
Year CE of current instant.
real(double) function moonmagn(pa, delta)
Calculate the magnitude of the Moon.
Planet data, needed to compute planet positions.
integer, parameter nplanpos
Number of entries in the planpos array.
integer pl0
Remember a special planet.
real(double), dimension(nplanpos) planpos
Planpos[] is an array with many different types of coordinates and related variables:
subroutine planet_position(jd, pl, lat, lon, hgt, lbaccur, raccur, ltime, aber, to_fk5, assume_jde, lunar_theory, nutat, magmdl, verbosity)
Compute the position, distance, etc of a planet.
subroutine planet_position_la(jd, pl, calc, nt, lat, lon)
Compute low-accuracy planet positions. Sun and Moon have dedicated routines, for planets abridged VSO...
Procedures to determine rise, transit and set times.
subroutine riset(jd, pl, rt, tt, st, rh, ta, sh, rsalt, for_night, ltime, cwarn, converge)
Rise, transit and set times routine for Sun, Moon, planets and asteroids. This version recomputes pos...
Procedures to determine the visibility of objects.
elemental real(double) function skybrightness_cdm2_from_nl(nl)
Convert sky brightness in nanolambert to candela per square meter.
subroutine planet_visibility_tonight(jd, pl, sunalt, plalt, comp, plvis, plazs, rts, tts, sts, ras, tas, sas, rscwarn)
Compute when a given planet is visible in a given night.
real(double) function transitalt(lat, dec)
Compute the transit altitude of an object with given declination for an observer with a given geograp...
elemental real(double) function skybrightness_cdm2_from_mlim(mlim)
Convert limiting visual magnitude to sky brightness in candela per square meter.
real(double) function best_planet_visibility(jd, pl)
Find a rough indication for the best moment (JD) to observe a planet on a given day (jd)....
real(double) function aperture(xsmag, pupil, tc)
Aperture diameter in centimetres needed to observe an object with given excess magnitude (0: no instr...
real(double) function airmass_la(alt)
Compute the airmass for a celestial object with a given apparent altitude; low-accuracy alternative f...
real(double) function extinction_fac(alt, ele)
Compute the extinction factor for an observer with given elevation and an object with given altitude.
subroutine limmag_skybrightness(year, sunalt, sunelon, moonphase, moonalt, moonelon, objalt, band1, band2, extcoef, skybr)
Calculate sky brightness based on Sun altitude and Moon phase.
elemental real(double) function skybrightness_nl_from_cdm2(cdm2)
Convert sky brightness in candela per square meter to nanolambert.
elemental real(double) function skybrightness_mas2_from_mlim(mlim)
Convert naked-eye visual limiting magnitude (V) to sky surface brightness in (B) magnitudes per squar...
real(double) function get_dra_obj(jd)
Compute the difference between a given right ascension and the RA of the Sun, used privately by best_...
real(double) function pl_xsmag_pl(jd)
Compute the excess magnitude at JD, wrapper for pl_xsmag() for solvers. The planet ID pl0 is passed t...
real(double) function extinction_mag(alt, ele)
Compute the extinction in magnitdes for an observer with given elevation and an object with given TRU...
real(double) function limmag_sun(sunalt)
Calculate limiting magnitude, based on the altitude of the Sun. Simplified version of limmag_full()
real(double) function extinction_magpam(ele)
Compute the extinction in magnitdes per unit airmass for an observer with given elevation.
real(double) function limmag_jd_pl(jd, pl)
Calculate limiting magnitude based on JD and planet ID, wrapper for limmag_jd()
real(double) function limmag_zenith_jd(jd, lat, lon, height)
Calculate limiting magnitude for the local zenith, based on JD and observer's location.
real(double) function airmass(alt)
Compute the airmass for a celestial object with a given TRUE altitude.
subroutine best_obs_date_ra(year, ra, accuracy, mon, dy)
Compute the best date in the year to observe an object with a given right ascension.
real(double) function pl_xsmag(jd, pl)
Compute the excess magnitude for planet pl at JD, considering Sun, Moon and airmass.
real(double) function limmag_full(year, month, obselev, obslat, sunalt, sunelon, moonphase, moonalt, moonelon, objalt, humid, airtemp, snrat, verbosity)
Calculate limiting magnitude based on Sun and Moon positions and phase, and on the altitude of the ob...
elemental real(double) function skybrightness_mlim_from_cdm2(cdm2)
Convert sky brightness in candela per square meter to naked-eye visual limiting magnitude (V)
real(double) function pl_xsmag_la_pl(jd)
Compute the excess magnitude at JD, wrapper for pl_xsmag_la() for solvers. The planet ID pl0 is passe...
subroutine limmag_extinction(month, obslat, obselev, objalt, relhum, temp, band1, band2, extcoef, extmag)
Calculate limiting magnitude based on Sun altitude and Moon phase.
logical function comet_invisible(jd, cometid, mlim, minalt)
Cheap function to determine whether a comet is invisible at a given time, based on a magnitude and al...
elemental real(double) function skybrightness_mlim_from_mas2(skybright)
Convert sky surface brightness in (B) magnitudes per square arcsecond to naked-eye visual limiting ma...
subroutine best_planet_xsmag(jdin, plid, jdout, xsmag, rscwarn)
Find the moment (JD) of optimal excess magnitude for a planet, i.e. the lowest mag - lim....
real(double) function limmag_sun_airmass(month, sunalt, sunaz, objalt, objaz, lat, height)
Calculate limiting magnitude based on Sun altitude and object altitude (airmass). Assumes New Moon.
real(double) function pl_xsmag_la(jd, pl)
Compute the excess magnitude for planet pl at JD, considering airmass and Sun alt - low-accuracy vers...
real(double) function limmag_jd(jd, objra, objdec, objalt, lat, height)
Calculate limiting magnitude based on JD and object altitude, wrapper for limmag_full()