"""File: moon_planner.py Plotting Moon altitude/elevation and speeds for a given site. moon_phase_angle and moon_illumination inspired by: https://docs.astropy.org/en/stable/generated/examples/ coordinates/plot_obs-planning.html Usage ----- >>python moon_elevation.py B12 2022-02-04 2022-02-04 This will produce a plot of the Moon conditions as seen from B12 (the Koschny Observatory) for the night 2022-02-04 to 2022-02-05. It will write it into a png file which can be visualized by an external programme. Or: >>python moon_planner.py "(4.4906, 52.07899, -65)" "2025-05-17" Versions -------- V1.0, 17 Feb 2025, dvk - First version, ready to be given to beta testers. V1.1, 20 Feb 2025, dvk - Added the possibility to pass observer coordinates. Notes ----- - IMPORTANT: When passing your own coordinates, it is important you use quotes around long, lat, height! See the example in 'Usage'. - Requires internet connection. - Requires the external file `horizon.xls`. - Requires the non-standard library `astroplan` - but for `observer` only I think. Might need cleaning up. - The first part of the code was developed beginning 2022; the rest beginning 2025. This might mean that there are some duplications here. Would need cleaning up. Still open ---------- - Make it work in time zones as the Americas and Asia. Currently the twilight shading seems to not yet work properly there. - Make sun_rise and sun_set work on Southern hemisphere. """ # ----------------------------------------------------------------------------- # Import the required libraries. # ----------------------------------------------------------------------------- import numpy as np import matplotlib.pyplot as plt import matplotlib.dates as mdates import matplotlib.ticker as mticker from matplotlib.patches import Circle, Wedge, Ellipse from matplotlib.offsetbox import OffsetImage, AnnotationBbox from scipy.interpolate import interp1d from astropy.coordinates import SkyCoord, EarthLocation, AltAz from astropy.coordinates import get_moon, get_sun import astropy.units as u from astropy.time import Time, TimeDelta from astropy.visualization import astropy_mpl_style, quantity_support from astropy.visualization import time_support from astroquery.mpc import MPC from astroplan import Observer import csv import sys import io # ---------------------------------------------------------------------------- # Define required routines. # ---------------------------------------------------------------------------- def validate_geo_params(longitude, latitude, height): return all([ -180 < longitude <= 180, -90 < latitude <= 90, -100 < height <= 5000 ]) # ---------------------------------------------------------------------------- def r_earth(lati): """Computing the radius of the Earth at a given latitude. Parameters ---------- lati : float Geodetic latitude in radians. Returns ------- radius : float Radius of the Earth in m. """ r_eq = 6378137.0 r_po = 6356752.0 radius = np.sqrt(((r_eq**2 * np.cos(lati))**2 + \ (r_po**2 * np.sin(lati))**2) / \ ((r_eq * np.cos(lati))**2 + \ (r_po * np.sin(lati))**2)) return radius # ---------------------------------------------------------------------------- def get_geo_coordinates(obs_code): """ Determine the longitude, latitude, and height of your site from an IAU observatory code. Parameters ---------- obs_code : string A three-letter string (can have numbers) to describe your IAU observatory code. E.g. 'B12' is the Koschny Observatory, 'J04' ESA's Optical Ground Station on Tenerife. Returns ------- geo_long : float Longitude of the location, in decimal degrees geo_lati : float Latitute of the location, in decimal degrees geo_height : float Height above geoid in m. """ r_eq = 6378137.0 # Earth radius at the equator. # Find the entry for the given code. If not found, return. try: obs = MPC.get_observatory_location(obs_code) except: raise Exception("No internet connection, or obsrvatory code "+ \ f"{obs_code} not found.") geo_long = obs[0].value # Needs `value` as this in a `quantity` geo_lati = np.arctan(obs[2] / obs[1]) * 180/np.pi geo_height = r_eq * obs[1] / np.cos(geo_lati * np.pi/180) \ - r_earth(geo_lati * np.pi/180) return geo_long, geo_lati, geo_height # ---------------------------------------------------------------------------- def read_horizon(horizon_file_name): """Reading the horizon. Parameters ---------- horizon_file_name : string File name containing the data - expects a csv file with azimuth and elevation. Returns ------- A tuple of azimuth/elevation pairs. """ horizon_data = [] with open(horizon_file_name, newline="") as csv_file: csv_reader = csv.reader(csv_file) try: for row in csv_reader: horizon_data.append([float(row[0]), float(row[1])]) except: raise Exception("csv file not in the right format.") return horizon_data # ------------------------------------------------------------------------------------------------ def moon_phase_angle(time): """ Compute the signed phase angle of the Moon. Parameters ---------- time : astropy.time.Time Times of observation. Returns ------- phase_angle : astropy.units.Quantity Signed phase angle of the Moon in degrees. - Positive (0Β° to +180Β°) β†’ Waxing Moon πŸŒ’πŸŒ“πŸŒ” - Negative (0Β° to -180Β°) β†’ Waning Moon πŸŒ–πŸŒ—πŸŒ˜ Notes ----- This routine was expanded by ChatGPT 4o from what was previously here - it now has signed values to indicate waxing vs. waning. """ sun = get_sun(time) moon = get_moon(time) elongation = sun.separation(moon) # Angular separation in degrees phase_angle = np.arctan2(sun.distance * np.sin(elongation), moon.distance - sun.distance * np.cos(elongation)) # πŸŒ’ Compute the Moon's velocity numerically using finite differences dt = TimeDelta(1, format="jd") # 1-day time step moon_future = get_moon(time + dt) moon_past = get_moon(time - dt) # Compute velocity as (future - past) / (2 * dt) moon_velocity = ((moon_future.cartesian.xyz - moon_past.cartesian.xyz) / (2 * dt.to(u.s))) # Compute Sun-to-Moon vector sun_moon_vector = (moon.cartesian - sun.cartesian).xyz # Dot product to determine waxing or waning waxing = np.dot(moon_velocity, sun_moon_vector) > 0 # True = Waxing, False = Waning # Apply sign: Waxing is positive, Waning is negative phase_angle_signed = phase_angle if waxing else -phase_angle return phase_angle_signed.to(u.deg) # Convert to degrees # ------------------------------------------------------------------------------------------------ def moon_illumination(time): """ Compute illuminated fraction of the Moon. Parameters ---------- time : astropy.time.Time Time of observation Returns ------- Illuminated fraction of the Moon ranging from 0 to 1 Notes ----- 17 Feb 2025, dvk: Currently not used. """ i = moon_phase_angle(time) return (1 + np.cos(i)) / 2.0 # ------------------------------------------------------------------------------------------------ def draw_moon_phase(phase_angle, size=0.2): """ Generates an in-memory image of the Moon phase to embed in the plot. Parameters ---------- phase_angle : float The Moon's phase angle in degrees. size : float, optional The size scaling factor for the Moon image. Returns ------- OffsetImage The image object to be placed in the figure. """ fig, ax = plt.subplots(figsize=(2, 2), dpi=100) ax.set_xlim([-1, 1]) ax.set_ylim([-1, 1]) ax.set_aspect("equal") ax.set_xticks([]) ax.set_yticks([]) ax.set_frame_on(False) xy_center = (0, 0) radius = size # Phase handling. Note: if anybody has a shorter way of doing this, let me # know! phase_angle = phase_angle.value # Extract number from astropy quantity. phase_rad = phase_angle * np.pi / 180 # Convert to radians, needed for np.cos(). if phase_angle < -179 or phase_angle > 179: # New Moon. my_patches = [Circle(xy_center, radius, edgecolor="black", facecolor="black")] elif 179 > phase_angle > 90: # Waxing Moon up to half Moon. my_patches = [Circle(xy_center, radius, edgecolor="black", facecolor="yellow"), Wedge(xy_center, radius, theta1=90, theta2=-90, facecolor="black"), Ellipse(xy_center, 2 * radius * np.cos(phase_rad), 2 * radius, facecolor="black")] elif phase_angle == 90: # Waxing half Moon (first quarter). my_patches = [Circle(xy_center, radius, edgecolor="black", facecolor="yellow"), Wedge(xy_center, radius, theta1=90, theta2=-90, facecolor="black")] elif 90 > phase_angle > 0: # Waxing Moon up to Full Moon. my_patches = [Circle(xy_center, radius, edgecolor="black", facecolor="black"), Wedge(xy_center, radius, theta1=-90, theta2=90, facecolor="yellow"), Ellipse(xy_center, 2 * radius * np.cos(phase_rad), 2 * radius, facecolor="yellow")] elif phase_angle == 0: # Full Moon. my_patches = [Circle(xy_center, radius, edgecolor="black", facecolor="yellow")] elif 0 > phase_angle > -90: # Waning Moon up to last quarter. my_patches = [Circle(xy_center, radius, edgecolor="black", facecolor="black"), Wedge(xy_center, radius, theta1=90, theta2=-90, facecolor="yellow"), Ellipse(xy_center, 2 * radius * np.cos(phase_rad), 2 * radius, facecolor="yellow")] elif -90 > phase_angle > -180: # Waning Moon from last quarter to New Moon. my_patches = [Circle(xy_center, radius, edgecolor="black", facecolor="yellow"), Wedge(xy_center, radius, theta1=-90, theta2=90, facecolor="black"), Ellipse(xy_center, 2 * radius * np.cos(phase_rad), 2 * radius, facecolor="black")] else: my_patches = [] # Placeholder for other phases # Add patches to plot for p in my_patches: ax.add_patch(p) # Save figure to memory so that it can be added later in a plot. buf = io.BytesIO() fig.savefig(buf, format='png', bbox_inches='tight', transparent=True) buf.seek(0) moon_img = plt.imread(buf, format="png") plt.close(fig) # In the following we use `OffsetImage` as that doesn't change with the axis ratio # of the plot. return OffsetImage(moon_img, zoom=size) # ------------------------------------------------------------------------------------------------ def moon_elevation(time, location): """Compute the Moon elevation in degrees Parameters ---------- time : astropy.time.Time The time Returns ------- Elevation of the Moon in degrees """ moon_coords = get_moon(time, location=location) moon_altaz = moon_coords.transform_to(AltAz(location=location)) return moon_altaz.alt # ----------------------------------------------------------------------------- def moon_azimuth(time, location): """Compute the Moon azimuth in degrees Parameters ---------- time : astropy.time.Time array time Returns ------- Azimuth of the Moon in degrees """ moon_coords = get_moon(time, location=location) moon_altaz = moon_coords.transform_to(AltAz(location=location)) return moon_altaz.az # ------------------------------------------------------------------------------------------------ def find_moon_horizon_crossing(time, moon_elev, moon_azim, horizon_data): """ Determine when the Moon appears above and disappears below the custom horizon. Parameters ---------- time : astropy.time.Time array Time array for observations. moon_elev : array Array of Moon elevations in degrees. moon_azim : array Array of Moon azimuths in degrees. horizon_data : list of tuples List of (azimuth, elevation) defining the horizon. Returns ------- moon_appearance_time : str The time when the Moon first appears above the horizon. moon_disappearance_time : str The time when the Moon disappears below the horizon. """ # Convert horizon data to numpy arrays horizon_az, horizon_el = np.array(horizon_data).T # Split into separate arrays # Ensure azimuth is sorted (in case the horizon file isn't in order) sorted_indices = np.argsort(horizon_az) horizon_az = horizon_az[sorted_indices] horizon_el = horizon_el[sorted_indices] # Interpolate horizon elevation for each Moon azimuth horizon_interp = interp1d(horizon_az, horizon_el, kind="linear", fill_value="extrapolate") horizon_at_moon_az = horizon_interp(moon_azim) # Find crossing points where Moon appears (crosses above) and disappears (crosses below) appears_above = np.where((moon_elev[:-1] < horizon_at_moon_az[:-1]) & (moon_elev[1:] > horizon_at_moon_az[1:]))[0] disappears_below = np.where((moon_elev[:-1] > horizon_at_moon_az[:-1]) & (moon_elev[1:] < horizon_at_moon_az[1:]))[0] # Get the first appearance and last disappearance times moon_appearance_time \ = time[appears_above[0] + 1] if appears_above.size > 0 else "No appearance" moon_disappearance_time \ = time[disappears_below[-1] + 1] if disappears_below.size > 0 else "No disappearance" return moon_appearance_time, moon_disappearance_time # ------------------------------------------------------------------------------------------------ def get_moon_culmination(times, moon_elev, moon_azim): """ Finds the time of the Moon's highest elevation (culmination). Parameters ---------- times : astropy.time.Time array Array of time steps. moon_elev : astropy.units.Quantity array Array of Moon elevation angles (same length as times). moon_azim : astropy.units.Quantity array Array of Moon azimuth angles (not used in computation but kept for consistency). Returns ------- culmination_time : astropy.time.Time The time when the Moon is at its highest elevation. culmination_elevation : astropy.units.Quantity The maximum elevation reached by the Moon. """ max_index = np.argmax(moon_elev) # Find index of maximum elevation culmination_time = times[max_index] # Get corresponding time culmination_elevation = moon_elev[max_index] # Get the max elevation return culmination_time, culmination_elevation # ------------------------------------------------------------------------------------------------ def sun_elevation(time, observer): """Compute the Sun elevation in degrees over a given time period.""" try: sun_coords = get_sun(time) # Get Sun's coordinates using AstroPy. except Exception as e: print(f"ERROR: get_sun() failed with {e}") return None try: # Check if `observer` is an `astroplan.Observer`, extract `.location` if needed if isinstance(observer, Observer): location = observer.location # Extract EarthLocation from Observer else: location = observer # Already an EarthLocation # Now pass the correct EarthLocation to AltAz altaz_frame = AltAz(location=location, obstime=time) sun_altaz = sun_coords.transform_to(altaz_frame) except Exception as e: print(f"ERROR: transform_to(AltAz) failed with {e}") return None return sun_altaz.alt # ------------------------------------------------------------------------------------------------ def compute_sun_events(time, location): """ Compute sunrise, sunset, and twilight times based on Sun elevation. Parameters ---------- time : astropy.time.Time or array-like A single time or an array of times. location : astropy.coordinates.EarthLocation Observer's location. Returns ------- Dict with: - "sunrise": Time of sunrise - "sunset": Time of sunset - "twilight_start": Time when evening civil twilight starts - "twilight_end": Time when morning civil twilight ends Notes ----- Some checks and conversions were added by ChatGPT. Not sure whether are all needed. """ # Convert time to astropy Time if it's not already if not isinstance(time, Time): try: time = Time(time) # Convert to astropy Time object except Exception as e: raise TypeError(f"Expected 'time' to be an astropy Time object, " + \ f"but got {type(time)}: {e}") sun_alt = sun_elevation(time, location) # Compute Sun altitude twilight_threshold = -6 * u.deg # Ensure correct units # Find where the Sun crosses key altitudes. sunrise_idx = np.where((sun_alt[:-1] < 0 * u.deg) & (sun_alt[1:] >= 0 * u.deg))[0] sunset_idx = np.where((sun_alt[:-1] >= 0 * u.deg) & (sun_alt[1:] < 0 * u.deg))[0] twilight_start_idx = \ np.where((sun_alt[:-1] > twilight_threshold) & (sun_alt[1:] <= twilight_threshold))[0] twilight_end_idx = \ np.where((sun_alt[:-1] <= twilight_threshold) & (sun_alt[1:] > twilight_threshold))[0] # Extract times at these indices. events = {} if len(sunrise_idx) > 0: events["sunrise"] = time[sunrise_idx[0]] if len(sunset_idx) > 0: events["sunset"] = time[sunset_idx[0]] if len(twilight_start_idx) > 0: events["twilight_start"] = time[twilight_start_idx[0]] if len(twilight_end_idx) > 0: events["twilight_end"] = time[twilight_end_idx[0]] return events # ------------------------------------------------------------------------------------------------ def add_twilight_shading(ax, time, location): """ Adds background shading for daytime, twilight, and darkness to a given axis. This is used in the upper right and lower right plots. Parameters ---------- ax : matplotlib.axes.Axes The axis where shading should be added. time : astropy.time.Time array Array of times over which shading should be applied. location : astropy.coordinates.EarthLocation Observer's location. """ sun_events = compute_sun_events(time, location) # Get sunrise/sunset/twilight times # Color definitions. daytime_color = "#FFFACD" twilight_color = "#FFB347" # Soft orange night_color = "#2B2B2B" # True dark gray # Extract events. sunrise = sun_events.get("sunrise", None) sunset = sun_events.get("sunset", None) twilight_start = sun_events.get("twilight_start", None) twilight_end = sun_events.get("twilight_end", None) # Get the plot's time range. plot_start = time[0] plot_end = time[-1] # Case 1: Standard case (Sunrise before Sunset). if sunset and sunrise and sunset > sunrise: # 🌞 Daytime shading. ax.axvspan(sunrise.plot_date, sunset.plot_date, facecolor=daytime_color, alpha=0.3, label="Daytime") # πŸŒ† Evening Twilight before sunset. if twilight_start: ax.axvspan(twilight_start.plot_date, sunset.plot_date, facecolor=twilight_color, alpha=0.3, label="Twilight") # πŸŒ‡ Morning Twilight after sunrise. if twilight_end: ax.axvspan(sunrise.plot_date, twilight_end.plot_date, facecolor=twilight_color, alpha=0.3) # πŸŒ‘ Nighttime between twilight_end and twilight_start. if twilight_end and twilight_start: ax.axvspan(twilight_end.plot_date, twilight_start.plot_date, facecolor=night_color, alpha=0.3, label="Darkness") # πŸ”Ή Case 2: Sunset before Sunrise (Overnight case). else: # πŸŒ‘ Nighttime from sunset (previous evening) to sunrise (next morning). if sunset and sunrise: ax.axvspan(sunset.plot_date, sunrise.plot_date, facecolor=night_color, alpha=0.3, label="Darkness") # πŸŒ† Evening Twilight before sunset. if twilight_start and sunset: ax.axvspan(twilight_start.plot_date, sunset.plot_date, facecolor=twilight_color, alpha=0.3, label="Twilight") # πŸŒ‡ Morning Twilight after sunrise. if twilight_end and sunrise: ax.axvspan(sunrise.plot_date, twilight_end.plot_date, facecolor=twilight_color, alpha=0.3) # 🌞 **Daytime fix: Start shading at plot start and extend to end if needed** if sunrise: ax.axvspan(plot_start.plot_date, sunrise.plot_date, facecolor=daytime_color, alpha=0.3, label="Daytime (Start)") if sunset: ax.axvspan(sunset.plot_date, plot_end.plot_date, facecolor=daytime_color, alpha=0.3, label="Daytime (End)") # ------------------------------------------------------------------------------------------------ # Now comes the routines for producing the four plots in the window. Where the upper left # one really just is text. # ------------------------------------------------------------------------------------------------ def plot_upper_left(time, loc): """Plotting upper left pane with sorted event times. Parameters ---------- time : astropy.time.Time Array with times. loc : astropy.EarthLocation The location of the observatory. Details ------- - The function now sorts events chronologically before printing. - Ensures times are formatted correctly without decimal seconds. """ # Store all events in a dictionary events = { "Moon rises": moonrise, "Moon appears": moon_appearance, "Moon highest": moon_culmination_time, "Moon disappears": moon_disappearance, "Moon sets": moonset, "Sun sets": sunset, "Sun rises": sunrise } # Convert values to `Time` objects (if they aren't already) event_times = { event: time_val if isinstance(time_val, Time) else Time(time_val) for event, time_val in events.items() \ if isinstance(time_val, Time) or "No" not in str(time_val) } # Sort events by time sorted_events = sorted(event_times.items(), key=lambda x: x[1]) # Prepare text lines line = np.arange(1, 0, -0.08) # Switch off the frame and ticks axs[0][0].set(frame_on=False) axs[0][0].xaxis.set_major_locator(mticker.NullLocator()) axs[0][0].yaxis.set_major_locator(mticker.NullLocator()) # Write title axs[0][0].text(0, line[0], r"$\bf{Location}$") axs[0][0].text(0, line[1], f"longitude: {loc.lon.value:9.5f}" + " deg (East is positive)") axs[0][0].text(0, line[2], f"latitude: {loc.lat.value:9.5f} deg (North is positive)") axs[0][0].text(0, line[3], f"height: {loc.height.value:.1f} m - " + f"Note: error ~70 m!") axs[0][0].text(0, line[4], "") # Write sorted events. Note: It might happen that `astroplan` doesn't find a Moon rise # time. Then it `masks` the relevant entry in the event list. This would throw an error # when attempting to print the value, thus the check with `np.ma.is_masked`. axs[0][0].text(0, line[5], r"$\bf{Events}$") for i, (event, event_time) in enumerate(sorted_events): if not np.ma.is_masked(event_time.value): # Only if the value is really there. formatted_time = event_time.datetime.strftime("%Y-%m-%d %H:%M:%S") axs[0][0].text(0, line[6 + i], f"{event}: {formatted_time}") # ------------------------------------------------------------------------------------------------ def plot_upper_right(time, loc): """Plotting the upper right pane: Delta Dec and Delta RA.""" # Compute RA and Dec of the Moon moon_coords = get_moon(time, location=loc) # Compute the differences (derivative of RA/Dec) delta_ra = np.diff(moon_coords.ra.value) * 3600 * u.arcsec / u.min delta_dec = np.diff(moon_coords.dec.value) * 3600 * u.arcsec / u.min # Ensure d_time matches the length of delta_ra and delta_dec d_time = time[:-1] # Correct length to match np.diff() output # Ensure data is not empty before plotting if len(delta_ra) == 0 or len(delta_dec) == 0: print("Warning: Ξ”RA or Ξ”Dec data is empty!") return # Exit early if there is no data # Plot Ξ”RA axs[0][1].plot(d_time.plot_date, delta_ra, label="Ξ”RA", color="blue") axs[0][1].set_ylabel("Ξ”RA in " + str(delta_ra.unit)) axs[0][1].set_ylim([10, 40]) # Set up the right y-axis for Ξ”Dec right_axis = axs[0][1].twinx() right_axis.set_ylabel("Ξ”Dec in " + str(delta_dec.unit), color="green") right_axis.yaxis.set_major_formatter(mticker.FormatStrFormatter("%-3.1f")) right_axis.plot(d_time.plot_date, delta_dec, color="green", label="Ξ”Dec") axs[0][1].get_shared_x_axes().join(axs[0][1], axs[1][1]) # Forces shared x-axis axs[0][1].set_xlim(axs[1][1].get_xlim()) # Force identical x-range # πŸ”Ή **Add background shading for daylight/twilight/darkness** add_twilight_shading(axs[0][1], time, ap_obs) # If the time span is more than a day, adjust the interval time_span_hours = (time[-1] - time[0]).to(u.hour).value tick_interval = 1 if time_span_hours <= 23 else 2 # 1-hour for short spans, 2-hour for longer # Set major ticks at full-hour intervals axs[0][1].xaxis.set_major_locator(mdates.HourLocator(interval=tick_interval)) # Format the labels to display only hours and minutes axs[0][1].xaxis.set_major_formatter(mdates.DateFormatter("%H:%M")) # πŸ”Ή **Force grid lines to match** axs[0][1].grid(True, which="both", linestyle="--", alpha=0.5) # Ensure consistent grid axs[0][1].xaxis.grid(True, which="major") # Force major grid alignment axs[0][1].xaxis.grid(True, which="minor", linestyle=":") # Minor grid (dashed) # Hide x-axis labels on the upper plot (to sync with the lower one) axs[0][1].set_xticklabels([]) # ------------------------------------------------------------------------------------------------ def plot_lower_left(time, loc): """Plotting the lower left pane: Elevation vs. Azimuth with event time labels. Parameters ---------- time : astropy.time.Time Array of times loc : astropy.EarthLocation The location of the observer. Returns ------- The plot with added time labels for important events. """ elev = moon_elevation(time, loc) azim = moon_azimuth(time, loc) horizon_data = read_horizon("horizon.csv") axs[1][0].set_xlim([45, 315]) axs[1][0].set_ylim([min_elev, max_elev]) # First plot all points from start time to sunset in yellow. azim1 = azim[np.where(time < sunset)] elev1 = elev[np.where(time < sunset)] axs[1][0].scatter(azim1, elev1, s=1, c="yellow") # Plot points from sunset to sunrise in blue. azim2 = azim[np.where(np.logical_and(time > sunset, time < sunrise))] elev2 = elev[np.where(np.logical_and(time > sunset, time < sunrise))] axs[1][0].scatter(azim2, elev2, s=2, c="blue", label="Sun below horizon") # Lastly, plot everything after sunrise in yellow again. azim3 = azim[np.where(time > sunrise)] elev3 = elev[np.where(time > sunrise)] axs[1][0].scatter(azim3, elev3, s=1, c="yellow", label="Sun above horizon") # Plot the horizon as a line connecting the points. h = np.transpose(horizon_data) axs[1][0].plot(h[0], h[1], "-g") # Link axis to lower right plot. axs[0][1].set_xlim(axs[1][1].get_xlim()) axs[1][0].set_xlabel("Azimuth in " + str(azim.unit)) axs[1][0].set_ylabel("Elevation in " + str(elev.unit)) axs[1][0].legend(loc="best", # Automatically chooses the best empty space frameon=True, # Adds a box around the legend framealpha=0.5, # Makes the legend semi-transparent facecolor="white", # Sets the background color edgecolor="gray", # Adds a subtle border fontsize=8) axs[1][0].grid() # Define the important events from the upper left panel important_events = {"Moon appearance": moon_appearance, "Moon culmination": moon_culmination_time, "Moon disappearance": moon_disappearance, "Sunset": sunset, "Sunrise": sunrise} # Loop over events and plot them for label, t in important_events.items(): if isinstance(t, Time): # Ensure it's a valid time az, el = moon_azimuth(t, loc).value, moon_elevation(t, loc).value if label == "Moon culmination": # Adding the cartoon of the Moon phase. NOTE: If the elevation is # reaching the top part of the plot, we have to move the cartoon # below the curve. phase_angle = moon_phase_angle(moon_culmination_time) moon_image = draw_moon_phase(phase_angle, size=0.4) if el > axs[1][0].get_ylim()[1] - 20: ab = AnnotationBbox(moon_image, (az, el - 15), frameon=False, xycoords="data") else: ab = AnnotationBbox(moon_image, (az, el + 10), frameon=False, xycoords="data") axs[1][0].add_artist(ab) plt.draw() # plt.pause(0.1) if 0 < el < axs[1][0].get_ylim()[1]: # Sometimes the sunrise or set is when the Moon is below the horizon. # Don't put the time in the plot in that case. axs[1][0].scatter([az], [el], color="gray", s=30, marker="o") # Mark event axs[1][0].text(az, el + 2, t.datetime.strftime("%Hh%Mm"), fontsize=8, ha="left", va="bottom", color="black", bbox=dict(facecolor="white", alpha=0.5, edgecolor="none", boxstyle="round,pad=0.2")) # ------------------------------------------------------------------------------------------------ def plot_lower_right(time, loc): """Plotting the lower right pane: Elevation vs. Time with full-hour time stamps. Parameters ---------- time : astropy.time.Time Array of times loc : astropy.EarthLocation The location of the observer. Returns ------- Plot with full-hour time labels. """ elev = moon_elevation(time, loc) axs[1][1].plot(time.plot_date, elev, color="blue") axs[1][1].set_ylim([min_elev, max_elev]) axs[1][1].set_xlabel("Time (UTC)") axs[1][1].set_ylabel("Elevation in " + str(elev.unit)) # Limit x-axis range to avoid excessive ticks axs[1][1].set_xlim(time[0].plot_date, time[-1].plot_date) # If the time span is more than a day, adjust the interval time_span_hours = (time[-1] - time[0]).to(u.hour).value tick_interval = 1 if time_span_hours <= 23 else 2 # 1-hour for short, 2-hour for longer. # Set major ticks at full-hour intervals axs[1][1].xaxis.set_major_locator(mdates.HourLocator(interval=tick_interval)) # Format the labels to display only hours and minutes axs[1][1].xaxis.set_major_formatter(mdates.DateFormatter("%H:%M")) # Rotate labels for better readability plt.setp(axs[1][1].get_xticklabels(), rotation=60, ha="right") # Add background shading for daylight/twilight/darkness. add_twilight_shading(axs[1][1], time, ap_obs) # Manually create legend handles for shading. from matplotlib.patches import Patch legend_patches = [ Patch(facecolor="yellow", alpha=0.3, label="Daytime"), Patch(facecolor="#FFB347", alpha=0.3, label="Twilight"), Patch(facecolor="#2C2C54", alpha=0.3, label="Darkness"), Patch(color="blue", label="Moon Elevation") # Keep existing curve label ] # Add the legend to the lower right plot. axs[1][1].legend(handles=legend_patches, loc="upper right", framealpha=0.7, fontsize=8) axs[1][1].grid() # ================================== Main program starting here. ================================= # ------------------------------------------------------------------------------------------------ # Define needed variables. # ------------------------------------------------------------------------------------------------ program_start_time = Time.now() if len(sys.argv) == 3: obs_code = sys.argv[1] start_date = sys.argv[2] end_date = start_date elif len(sys.argv) == 4: obs_code = sys.argv[1] start_date = sys.argv[2] end_date = sys.argv[3] else: obs_code = "B12" # Defaults to Koschny Observatory in Noordwijkerhout. start_date = "2025-03-09" end_date = "2025-03-09" print(f"Starting moon_planner.py with obs_code = {obs_code}, start_date = {start_date}") # Read observing location. if "(" in obs_code: # Take the beginning parentheses as an indication that the obs_code is a tuple. # Check the input for validity. arg = obs_code.strip("()") geo_long, geo_lati, geo_height = map(float, arg.split(",")) if validate_geo_params(geo_long, geo_lati, geo_height): # print("All input parameters are valid.") pass else: print("Invalid input parameters - check that -90 < longitude < +90, " + \ "-180 < latitude <= 180, -100 < height <5000.") print("Leaving moon_planner.py.") sys.exit() else: geo_long, geo_lati, geo_height = get_geo_coordinates(obs_code) obs_loc = EarthLocation(lon=geo_long * u.deg, lat=geo_lati * u.deg, height=geo_height * u.m) # Define an `astroplan` observer to compute rise and set times ap_obs = Observer(location=obs_loc) date_array = Time(start_date) \ + TimeDelta(np.arange((Time(end_date) - Time(start_date)).jd + 1), format="jd") # Loop to go from start_date to end_date. for date in date_array: # Setting start and end time of plot. # start_time = Time(date + " 12:00:00", format="iso", out_subfmt="date_hm") start_time = date + TimeDelta(0.5 * u.day) end_time = start_time + 1 * u.day # Always 1 day fig_size = (11.69, 8.27) # Set up a figure. 11.69" x 8.27" = DIN A4. min_elev = 0 # Minimum shown elevation in all plots. max_elev = 70 # Maximum shown elevation in all plots. # -------------------------------------------------------------------------------------------- # Compute delta times, time steps, sunrise, sunset. # -------------------------------------------------------------------------------------------- delta_time = end_time - start_time step_in_days = 1 / (delta_time.value) step_in_hours = 1 / (delta_time.value * 24) step_in_minutes = 1 / (delta_time.value * 24 * 60) # Creating an array of `time` with given step size. It looks # like for daily plots, a step size of minutes is best. times = start_time + delta_time * np.arange(0, 1, step_in_minutes) sunrise = ap_obs.sun_rise_time(time=end_time) sunset = ap_obs.sun_set_time(time=start_time) # Compute Moon elevation and azimuth over time moon_elev = moon_elevation(times, obs_loc).value moon_azim = moon_azimuth(times, obs_loc).value moonrise = ap_obs.moon_rise_time(time=start_time, which="next") moonset = ap_obs.moon_set_time(time=start_time, which="next") moon_culmination_time, moon_culmination_elevation \ = get_moon_culmination(times, moon_elev, moon_azim) # -------------------------------------------------------------------------------------------- # Compute moon rise and set times for custom horizon. Implemented 15 Feb 2025, with ChatGPT 4o. # -------------------------------------------------------------------------------------------- # Load horizon data horizon_data = read_horizon("horizon.csv") # Find Moon's appearance and disappearance times moon_appearance, moon_disappearance = find_moon_horizon_crossing(times, moon_elev, moon_azim, horizon_data) # -------------------------------------------------------------------------------------------- # Do the work. # -------------------------------------------------------------------------------------------- # Enable proper time support in matplotlib. time_support() sun_events = compute_sun_events(times, obs_loc) # Set up a 2 x 2 plot. The upper left area is used only for text. fig, axs = plt.subplots(2, 2, figsize=fig_size, constrained_layout=True) fig.set_facecolor("whitesmoke") fig.suptitle('Moon viewing conditions ' + times[0].value.split(' ')[0], fontsize=14) # Plot everything print("Starting the plot generation", end="") plot_upper_left(times, obs_loc) plot_upper_right(times, obs_loc) plot_lower_left(times, obs_loc) plot_lower_right(times, obs_loc) out_file_name = obs_code + "_" + date.strftime("%Y-%m-%d") + ".png" plt.savefig(out_file_name, format="png") print() print("File written: ", out_file_name) plt.close(fig) program_end_time = Time.now() print("Run time was ", program_end_time.value - program_start_time.value) print(" - Done.") # ============================================ eof ===============================================