#!/usr/bin/env python3
###############################################################################
# This file is part of SWIFT.
# Copyright (c) 2022 Mladen Ivkovic (mladen.ivkovic@hotmail.com)
#
# This program is free software: you can redistribute it and/or modify
# it under the terms of the GNU Lesser General Public License as published
# by the Free Software Foundation, either version 3 of the License, or
# (at your option) any later version.
#
# This program 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 Lesser General Public License
# along with this program.  If not, see .
#
##############################################################################
# ----------------------------------------------------
# Plot slices of the neutral hydrogen number density,
# pressure, temperature, and neutral hydrogen mass fraction.
# ----------------------------------------------------
import gc
import sys
import matplotlib as mpl
import swiftsimio
import unyt
from matplotlib import pyplot as plt
from matplotlib.colors import LogNorm
from mpl_toolkits.axes_grid1 import make_axes_locatable
from swiftsimio.visualisation.slice import slice_gas
import stromgren_plotting_tools as spt
# Parameters users should/may tweak
# snapshot basename
snapshot_base = "output"
# parameters for imshow plots
imshow_kwargs = {"origin": "lower"}
# parameters for swiftsimio slices
slice_kwargs = {"resolution": 1024, "parallel": True}
# -----------------------------------------------------------------------
# Read in cmdline arg: Are we plotting only one snapshot, or all?
plot_all = False
snapnr = -1
try:
    snapnr = int(sys.argv[1])
except IndexError:
    plot_all = True
mpl.rcParams["text.usetex"] = True
def set_colorbar(ax, im):
    """
    Adapt the colorbar a bit for axis object  and
    imshow instance 
    """
    divider = make_axes_locatable(ax)
    cax = divider.append_axes("right", size="5%", pad=0.05)
    plt.colorbar(im, cax=cax)
    return
def plot_result(filename):
    """
    Create and save the plot
    """
    print("working on", filename)
    data = swiftsimio.load(filename)
    meta = data.metadata
    scheme = str(meta.subgrid_scheme["RT Scheme"].decode("utf-8"))
    global imshow_kwargs
    imshow_kwargs["extent"] = [
        0.0 * meta.boxsize[0].v,
        0.9 * meta.boxsize[0].v,
        0.0 * meta.boxsize[1].v,
        0.9 * meta.boxsize[1].v,
    ]
    try:
        par = meta.parameters["InitialConditions:periodic"]
        periodic = int(par) == 1
    except KeyError:
        periodic = False
    # Add a cutoff to the image edges if the run wasn't periodic
    cutoff = int(0.05 * slice_kwargs["resolution"])
    mass_map = slice_gas(
        data, project="masses", z_slice=0.5 * meta.boxsize[2], **slice_kwargs
    )
    gamma = meta.gas_gamma
    imf = spt.get_imf(scheme, data)
    # use units that are most likely not to produce infinities and NaNs
    masses_MSun = data.gas.masses.to("M_Sun")
    data.gas.mXHI = imf.HI * masses_MSun
    data.gas.mXHII = imf.HII * masses_MSun
    data.gas.mP = data.gas.pressures * masses_MSun
    data.gas.mrhoHI = imf.HI * data.gas.densities * masses_MSun
    mu = spt.mean_molecular_weight(imf.HI, imf.HII, imf.HeI, imf.HeII, imf.HeIII)
    data.gas.mT = (
        spt.gas_temperature(data.gas.internal_energies, mu, gamma) * masses_MSun
    )
    mass_weighted_HI_map = slice_gas(
        data, project="mXHI", z_slice=0.5 * meta.boxsize[2], **slice_kwargs
    )
    mass_weighted_pressure_map = slice_gas(
        data, project="mP", z_slice=0.5 * meta.boxsize[2], **slice_kwargs
    )
    mass_weighted_HI_density_map = slice_gas(
        data, project="mrhoHI", z_slice=0.5 * meta.boxsize[2], **slice_kwargs
    )
    mass_weighted_temperature_map = slice_gas(
        data, project="mT", z_slice=0.5 * meta.boxsize[2], **slice_kwargs
    )
    HI_map = mass_weighted_HI_map / mass_map
    if not periodic:
        HI_map = HI_map[cutoff:-cutoff, cutoff:-cutoff]
    pressure_map = mass_weighted_pressure_map / mass_map
    if not periodic:
        pressure_map = pressure_map[cutoff:-cutoff, cutoff:-cutoff]
    pressure_map = pressure_map.to("g/cm/s**2")
    HI_density_map = mass_weighted_HI_density_map / mass_map
    if not periodic:
        HI_density_map = HI_density_map[cutoff:-cutoff, cutoff:-cutoff]
    HI_density_map = HI_density_map.to("kg/cm**3")
    HI_density_map = HI_density_map / unyt.proton_mass
    temperature_map = mass_weighted_temperature_map / mass_map
    if not periodic:
        temperature_map = temperature_map[cutoff:-cutoff, cutoff:-cutoff]
    temperature_map = temperature_map.to("K")
    fig = plt.figure(figsize=(12, 12), dpi=200)
    figname = filename[:-5] + ".png"
    ax1 = fig.add_subplot(221)
    ax2 = fig.add_subplot(222)
    ax3 = fig.add_subplot(223)
    ax4 = fig.add_subplot(224)
    try:
        im1 = ax1.imshow(
            HI_density_map.T,
            **imshow_kwargs,
            norm=LogNorm(vmin=1.0e-6, vmax=1e-1),
            cmap="bone",
        )
        set_colorbar(ax1, im1)
        ax1.set_title(r"Neutral Hydrogen Number Density [cm$^{-3}$]")
    except (ValueError, TypeError):
        print(
            filename,
            "densities wrong? min",
            data.gas.densities.min(),
            "max",
            data.gas.densities.max(),
        )
        return
    try:
        im2 = ax2.imshow(
            HI_map.T,
            **imshow_kwargs,
            norm=LogNorm(vmin=1.0e-5, vmax=1.0),
            cmap="cividis",
        )
        set_colorbar(ax2, im2)
        ax2.set_title("Neutral Hydrogen Mass Fraction [1]")
    except (ValueError, TypeError):
        print(
            filename,
            "mass fraction wrong? min",
            data.gas.ion_mass_fractions.HI.min(),
            "max",
            data.gas.ion_mass_fractions.HI.max(),
        )
        return
    try:
        im3 = ax3.imshow(
            pressure_map.T,
            **imshow_kwargs,
            norm=LogNorm(vmin=1e-15, vmax=1e-12),
            cmap="viridis",
        )
        set_colorbar(ax3, im3)
        ax3.set_title(r"Pressure [g/cm/s$^2$]")
    except (ValueError, TypeError):
        print(
            filename,
            "pressures wrong? min",
            data.gas.pressures.min(),
            "max",
            data.gas.pressures.max(),
        )
        return
    try:
        im4 = ax4.imshow(
            temperature_map.T,
            **imshow_kwargs,
            norm=LogNorm(vmin=1e2, vmax=5e4),
            cmap="inferno",
        )
        set_colorbar(ax4, im4)
        ax4.set_title(r"Temperature [K]")
    except (ValueError, TypeError):
        print(
            filename,
            "temperatures wrong? min",
            temperature_map.min(),
            "max",
            temperature_map.max(),
        )
        return
    for ax in [ax1, ax2, ax3, ax4]:
        ax.set_xlabel("[kpc]")
        ax.set_ylabel("[kpc]")
    title = filename.replace("_", "\_")  # exception handle underscore for latex
    if meta.cosmology is not None:
        title += ", $z$ = {0:.2e}".format(meta.z)
    title += ", $t$ = {0:.1f}".format(meta.time.to("Myr"))
    fig.suptitle(title)
    plt.tight_layout()
    plt.savefig(figname)
    plt.close()
    gc.collect()
    return
if __name__ == "__main__":
    snaplist = spt.get_snapshot_list(snapshot_base, plot_all, snapnr)
    for f in snaplist:
        plot_result(f)