SuperNOVAS v1.5
The NOVAS C library, made better
Loading...
Searching...
No Matches
SuperNOVAS vs. astropy

Nowadays astropy is widely used in the astronomy community and it is known for its simplicity and elegance, but it is rather slow (putting it mildly). In contrast, C is known to be fast, but it also has a bad reputation for being tedious and 'ugly'. However, below is a side-by-side comparison of equivalent program snippets for calculating CIRS apparent positions in astropy vs. SuperNOVAS for Antares for a given date and observer location:

astropy SuperNOVAS

from astropy import units as u
from astropy.coordinates import SkyCoord,
EarthLocation, Longitude, Latitude,
CIRS
# Define ICRS coordinates
source = SkyCoord(
'16h 29m 24.45970s',
'−26d 25m 55.2094s',
d = u.AU / 5.89 * u.mas,
pmra = -12.11 * u.mas / u.yr,
pmdec = -23.30 * u.mas / u.yr,
rv = -3.4 * u.km / u.s)
# Observer location
loc = EarthLocation.from_geodetic(
Longitude(50.7374),
Latitude(7.0982),
height=60.0)
# Set time of observation
time = astropy.time.Time(
"2025-02-27T19:57:00.728+0200"
scale='tai')
# Observer frame & system
frame = CIRS(obstime=time, location=loc)
# apparent coordinates
apparent = source.transform_to(frame);

#include <novas.h>
cat_entry star;
object source;
sky_pos apparent;
// Define ICRS coordinates
make_cat_entry("Antares", "ICRS", 1,
novas_hms_hours("16h 29m 24.45970s"),
novas_dms_degrees("−26d 25m 55.2094s"),
-12.11, -23.30, 5.89, -3.4, &star);
make_cat_object(&star, &source);
// Observer location
make_gps_observer(50.7374, 7.0982, 60.0,
&loc);
// Set time of observation
"2025-02-27T19:57:00.728+0200",
LEAP_SECONDS, DUT1, &time);
// Observer frame
&loc, &time, DX, DY, &frame);
// apparent coordinates in system
novas_sky_pos(&source, &frame, NOVAS_CIRS,
&apparent);
int novas_sky_pos(const object *restrict object, const novas_frame *restrict frame, enum novas_reference_system sys, sky_pos *restrict out)
Definition frames.c:757
int novas_make_frame(enum novas_accuracy accuracy, const observer *obs, const novas_timespec *time, double xp, double yp, novas_frame *frame)
Definition frames.c:437
@ NOVAS_FULL_ACCURACY
Definition novas.h:584
@ NOVAS_CIRS
Definition novas.h:505
@ NOVAS_TAI
Innternational Atomic Time (TAI)
Definition novas.h:1276
int make_gps_observer(double latitude, double longitude, double height, observer *obs)
Definition observer.c:251
double novas_hms_hours(const char *restrict hms)
Definition parse.c:244
double novas_dms_degrees(const char *restrict dms)
Definition parse.c:459
Definition novas.h:866
Definition novas.h:1390
Definition novas.h:1301
Definition novas.h:1207
Definition novas.h:1236
short make_cat_entry(const char *restrict name, const char *restrict catalog, long cat_num, double ra, double dec, double pm_ra, double pm_dec, double parallax, double rad_vel, cat_entry *source)
Definition target.c:312
int make_cat_object(const cat_entry *star, object *source)
Definition target.c:480
int novas_set_str_time(enum novas_timescale timescale, const char *restrict str, int leap, double dut1, novas_timespec *restrict time)
Definition timescale.c:510

Yes, SuperNOVAS is a bit more verbose, but not painfully so. OK, it's cheating a little bit, but only to make a point. If you look closer, you'll see that some details have been glazed over. For example, astropy will automatically fetch IERS data (leap seconds, and Earth-orientation parameters), whereas in SuperNOVAS you will have to set these explicitly (hence the placeholder LEAP_SECONDS, DUT1, DX and DY constants in the C snippet above). And, of course, the above comparison ignores error checking also. In Python, you can simply surround the above code in a try block, and then catch errors using except. In C, there is no catch-all solution like that. Instead, you will have to check the return values for each line, and decide if you need to bail early, e.g.:

if(make_cat_object(&star, &source) != 0) {
// oops, the above failed, bail if we must...
return -1;
}

Regardless of the slight omissions, the difference is not night and day. If you can handle astropy, chances are you can handle SuperNOVAS too. And the reward for dealing with slightly 'uglier' code, is orders of magnitude gain in the speed of execution. It is a trade-off that worth considering, at the least.


Copyright (C) 2025 Attila Kovács