Skip to content
simpler_model.ran.ipynb 2.56 MiB
Newer Older
{
 "cells": [
  {
   "cell_type": "markdown",
   "id": "subjective-vocabulary",
   "metadata": {
    "papermill": {
     "duration": 0.0663,
     "end_time": "2021-07-29T09:48:55.198983",
     "start_time": "2021-07-29T09:48:55.132683",
     "status": "completed"
    },
    "tags": []
   },
   "source": [
    "# **Location of the stress factor in potential evapo-transpiration models**"
   ]
  },
  {
   "cell_type": "markdown",
   "id": "adaptive-visit",
   "metadata": {
    "papermill": {
     "duration": 0.054514,
     "end_time": "2021-07-29T09:48:55.307660",
     "start_time": "2021-07-29T09:48:55.253146",
     "status": "completed"
    },
    "slideshow": {
     "slide_type": "slide"
    },
    "tags": []
   },
   "source": [
    "# Part I - Methodology \n",
    "\n",
    "## <u> Motivation </u> \n",
    "\n",
    "### Theoretical background\n",
    "\n",
    "In the literature, this scaling of the potential evapo-transpiration is commonly found with simpler radiation-temperature models such as the Priestley and Taylor model instead of the Penman-Monteith one. Recall the expression of the Priestley and Taylor model: \n",
    "\n",
    "\\begin{equation}\\label{eq_PT}\n",
    "    \\lambda E_{p,PT} = \\alpha \\frac{\\Delta}{\\Delta + \\gamma}(Rn - G)\n",
    "\\end{equation}\n",
    "\n",
    "The Priestley and Taylor is not physicaly based as can be the Penman-Monteith model. Then we aim at investigating the differences obtained when using such a model. \n",
    "\n",
    "This notebook compares different newly implemented models : \n",
    "* Priestley and Taylor model with a stress factor : \n",
    "\\begin{align}\n",
    "    E_{a, PT}  = f_{PAR}.S(\\theta).E_{p,PT}(\\textbf{X})\n",
    "\\end{align}\n",
    "\n",
    "* Modified varying surface conductance Penman-Monteith model :\n",
    "\\begin{align}\n",
    "    E_{a, var, PM}  = f_{PAR}.E_{p,PM mod}(\\textbf{X}, S(\\theta))\n",
    "\\end{align}\n",
    "\n",
    "* Modified constant surface conductance Penman-Monteith model :\n",
    "\\begin{align}\n",
    "    E_{a, cst, PM}  = f_{PAR}.S(\\theta).E_{p,PM mod}(\\textbf{X})\n",
    "\\end{align}\n",
    "\n",
    "The modified version of the Penman-Monteith equation takes into account the double sided exchange of sensible heat. This model was developped at the leaf scale but is tested here at the canopy scale in the framework of the big leaf model (*Schymanski and Or, 2017*). The analytical expression of the modified expression is henceforth: \n",
    "\\begin{equation}\n",
    "E = \\frac{1}{\\lambda}\\frac{\\Delta (R_n - G) + c_p \\rho_a g_a a_{sh} VPD }{\\Delta + \\gamma \\left( 1+ \\frac{g_a}{g_s} \\right) \\frac{a_{sh}}{a_s}}\n",
    "\\end{equation}\n",
    "\n",
    "### Modelling experiements\n",
    "\n",
    "Different experiments are carried out to compare the different models and assess their behavior: \n",
    "1. All models are calibrated for a single year and their ability to reproduce an observed time serie is assessed\n",
    "2. Their prediction capability is evaluated by randomly taking one or several years of data from the Howard Springs dataset, calibrating the model for this specific year and predicting the evapo-transpiration time serie for the other years. \n",
    "3. The same procedure is repeated across different sites in Australia"
   ]
  },
  {
   "cell_type": "markdown",
   "id": "abandoned-nickel",
   "metadata": {
    "papermill": {
     "duration": 0.056467,
     "end_time": "2021-07-29T09:48:55.420196",
     "start_time": "2021-07-29T09:48:55.363729",
     "status": "completed"
    },
    "tags": []
   },
   "source": [
    "# Part II - Functions set up"
   ]
  },
  {
   "cell_type": "markdown",
   "id": "vocal-meditation",
     "duration": 0.05539,
     "end_time": "2021-07-29T09:48:55.530936",
     "start_time": "2021-07-29T09:48:55.475546",
     "status": "completed"
    },
    "tags": []
   },
   "source": [
    "## Importing relevant packages"
   ]
  },
  {
   "cell_type": "code",
   "execution_count": 1,
   "id": "angry-vietnamese",
     "iopub.execute_input": "2021-07-29T09:48:55.660437Z",
     "iopub.status.busy": "2021-07-29T09:48:55.643496Z",
     "iopub.status.idle": "2021-07-29T09:48:59.288506Z",
     "shell.execute_reply": "2021-07-29T09:48:59.287701Z"
     "duration": 3.703842,
     "end_time": "2021-07-29T09:48:59.288762",
     "start_time": "2021-07-29T09:48:55.584920",
     "status": "completed"
    },
    "tags": []
   },
   "outputs": [
    {
     "name": "stderr",
     "output_type": "stream",
     "text": [
      "WARNING (aesara.link.c.cmodule): install mkl with `conda install mkl-service`: No module named 'mkl'\n"
     ]
    },
    {
     "name": "stderr",
     "output_type": "stream",
     "text": [
      "WARNING (aesara.tensor.blas): Using NumPy C-API based implementation for BLAS functions.\n"
     ]
    }
   ],
   "source": [
    "# data manipulation and plotting\n",
    "import pandas as pd\n",
    "import matplotlib.pyplot as plt\n",
    "from matplotlib.patches import Polygon\n",
    "from matplotlib._layoutgrid import plot_children\n",
    "from collections import OrderedDict\n",
    "from IPython.display import display\n",
    "import os # to look into the other folders of the project\n",
    "import importlib.util # to open the .py files written somewhere else\n",
    "#sns.set_theme(style=\"whitegrid\")\n",
    "\n",
    "# Sympy and sympbolic mathematics\n",
    "from sympy import (asin, cos, diff, Eq, exp, init_printing, log, pi, sin, \n",
    "                   solve, sqrt, Symbol, symbols, tan, Abs)\n",
    "from sympy.physics.units import convert_to\n",
    "init_printing() \n",
    "from sympy.printing import StrPrinter\n",
    "from sympy import Piecewise\n",
    "StrPrinter._print_Quantity = lambda self, expr: str(expr.abbrev)    # displays short units (m instead of meter)\n",
    "from sympy.printing.aesaracode import aesara_function\n",
    "from sympy.physics.units import *    # Import all units and dimensions from sympy\n",
    "from sympy.physics.units.systems.si import dimsys_SI, SI\n",
    "\n",
    "# for ESSM, environmental science for symbolic math, see https://github.com/environmentalscience/essm\n",
    "from essm.variables._core import BaseVariable, Variable\n",
    "from essm.equations import Equation\n",
    "from essm.variables.units import derive_unit, SI, Quantity\n",
    "from essm.variables.utils import (extract_variables, generate_metadata_table, markdown, \n",
    "                                  replace_defaults, replace_variables, subs_eq)\n",
    "from essm.variables.units import (SI_BASE_DIMENSIONS, SI_EXTENDED_DIMENSIONS, SI_EXTENDED_UNITS,\n",
    "                                  derive_unit, derive_baseunit, derive_base_dimension)\n",
    "\n",
    "# For netCDF\n",
    "import netCDF4\n",
    "import numpy as np\n",
    "import xarray as xr\n",
    "import warnings\n",
    "from netCDF4 import Dataset\n",
    "\n",
    "# For regressions\n",
    "from sklearn.linear_model import LinearRegression\n",
    "\n",
    "# Deactivate unncessary warning messages related to a bug in Numpy\n",
    "warnings.simplefilter(action='ignore', category=FutureWarning)\n",
    "\n",
    "# for calibration\n",
    "from scipy import optimize\n",
    "\n",
    "from random import random"
   ]
  },
  {
   "cell_type": "markdown",
   "id": "republican-allergy",
     "duration": 0.056647,
     "end_time": "2021-07-29T09:48:59.408586",
     "start_time": "2021-07-29T09:48:59.351939",
     "status": "completed"
    },
    "tags": []
   },
   "source": [
    "## Path of the different files (pre-defined python functions, sympy equations, sympy variables)"
   ]
  },
  {
   "cell_type": "code",
   "execution_count": 2,
   "id": "scheduled-course",
     "iopub.execute_input": "2021-07-29T09:48:59.526308Z",
     "iopub.status.busy": "2021-07-29T09:48:59.525483Z",
     "iopub.status.idle": "2021-07-29T09:48:59.528943Z",
     "shell.execute_reply": "2021-07-29T09:48:59.528359Z"
     "duration": 0.065221,
     "end_time": "2021-07-29T09:48:59.529079",
     "start_time": "2021-07-29T09:48:59.463858",
     "status": "completed"
    },
    "tags": [
     "parameters"
    ]
   },
   "outputs": [],
   "source": [
    "path_variable = '../../theory/pyFile_storage/theory_variable.py'\n",
    "path_equation = '../../theory/pyFile_storage/theory_equation.py' \n",
    "path_analysis_functions = '../../theory/pyFile_storage/analysis_functions.py'\n",
    "path_data = '../../../data/eddycovdata/'\n",
    "dates_fPAR = '../../../data/fpar_howard_spring/dates_v5'\n",
    "\n",
    "tex_file_whole = \"latex_files/whole_year.tex\"\n",
    "tex_file_dry = \"latex_files/dry_season.tex\"\n",
    "tex_file_wet = \"latex_files/wet_season.tex\"\n",
    "\n",
    "timeSerie_oneSite_oneYear = 'timeSerie_oneSite_oneYear.png'\n",
    "inverseModelling = \"inverseModelling.png\"\n",
    "Influence_atmo_E_dry = \"Influence_atmo_E_dry.png\"\n",
    "Influence_atmo_E_wet = \"Influence_atmo_E_wet.png\"\n",
    "Influence_atmo_rel_dry = \"Influence_atmo_rel_dry.png\"\n",
    "Influence_atmo_rel_dry_sturt = \"Influence_atmo_rel_dry_sturt.png\"\n",
    "Influence_atmo_rel_wet = \"Influence_atmo_rel_wet.png\"\n",
    "Influence_atmo_rel_compa = \"Influence_atmo_rel_compa.png\"\n",
    "sensitivity_parameters = \"sensitivity_parameters.png\"\n",
    "statistical_assessment = \"statistical_assessment.png\"\n",
    "different_sites = \"different_sites.png\"\n",
    "theta_CC = \"theta_CC.png\"\n",
    "theta_gs_relation = \"theta_gs_relation.png\""
   ]
  },
  {
   "cell_type": "code",
   "execution_count": 3,
   "id": "acute-crystal",
     "iopub.execute_input": "2021-07-29T09:48:59.651653Z",
     "iopub.status.busy": "2021-07-29T09:48:59.649934Z",
     "iopub.status.idle": "2021-07-29T09:48:59.655340Z",
     "shell.execute_reply": "2021-07-29T09:48:59.653788Z"
     "duration": 0.071605,
     "end_time": "2021-07-29T09:48:59.655701",
     "start_time": "2021-07-29T09:48:59.584096",
     "status": "completed"
    },
    "tags": [
     "injected-parameters"
    ]
   },
   "outputs": [],
   "source": [
    "# Parameters\n",
    "path_variable = \"notebooks/theory/pyFile_storage/theory_variable.py\"\n",
    "path_equation = \"notebooks/theory/pyFile_storage/theory_equation.py\"\n",
    "path_analysis_functions = \"notebooks/theory/pyFile_storage/analysis_functions.py\"\n",
    "path_data = \"data/eddycovdata/\"\n",
    "dates_fPAR = \"data/fpar_howard_spring/dates_v5\"\n",
    "timeSerie_oneSite_oneYear = (\n",
    "    \"notebooks/Finished_project/simpler_model/timeSerie_oneSite_oneYear.png\"\n",
    ")\n",
    "inverseModelling = \"notebooks/Finished_project/simpler_model/inverseModelling.png\"\n",
    "Influence_atmo_E_dry = (\n",
    "    \"notebooks/Finished_project/simpler_model/Influence_atmo_E_dry.png\"\n",
    ")\n",
    "Influence_atmo_E_wet = (\n",
    "    \"notebooks/Finished_project/simpler_model/Influence_atmo_E_wet.png\"\n",
    ")\n",
    "Influence_atmo_rel_dry = (\n",
    "    \"notebooks/Finished_project/simpler_model/Influence_atmo_rel_dry.png\"\n",
    ")\n",
    "Influence_atmo_rel_dry_sturt = (\n",
    "    \"notebooks/Finished_project/simpler_model/Influence_atmo_rel_dry_sturt.png\"\n",
    ")\n",
    "Influence_atmo_rel_wet = (\n",
    "    \"notebooks/Finished_project/simpler_model/Influence_atmo_rel_wet.png\"\n",
    ")\n",
    "Influence_atmo_rel_compa = (\n",
    "    \"notebooks/Finished_project/simpler_model/Influence_atmo_rel_compa.png\"\n",
    ")\n",
    "sensitivity_parameters = (\n",
    "    \"notebooks/Finished_project/simpler_model/sensitivity_parameters.png\"\n",
    ")\n",
    "statistical_assessment = (\n",
    "    \"notebooks/Finished_project/simpler_model/statistical_assessment.png\"\n",
    ")\n",
    "different_sites = \"notebooks/Finished_project/simpler_model/different_sites.png\"\n",
    "theta_CC = \"notebooks/Finished_project/simpler_model/theta_CC.png\"\n",
    "theta_gs_relation = \"notebooks/Finished_project/simpler_model/theta_gs_relation.png\"\n",
    "tex_file_whole = \"notebooks/Finished_project/simpler_model/latex_files/whole_year.tex\"\n",
    "tex_file_dry = \"notebooks/Finished_project/simpler_model/latex_files/dry_season.tex\"\n",
    "tex_file_wet = \"notebooks/Finished_project/simpler_model/latex_files/wet_season.tex\"\n"
   ]
  },
  {
   "cell_type": "markdown",
   "id": "distinguished-possibility",
     "duration": 0.055035,
     "end_time": "2021-07-29T09:48:59.780245",
     "start_time": "2021-07-29T09:48:59.725210",
     "status": "completed"
    },
    "tags": []
   },
   "source": [
    "## Importing the sympy variables and equations defined in the theory.ipynb notebook"
   ]
  },
  {
   "cell_type": "code",
   "execution_count": 4,
   "id": "incorporate-specialist",
     "iopub.execute_input": "2021-07-29T09:48:59.900504Z",
     "iopub.status.busy": "2021-07-29T09:48:59.899949Z",
     "iopub.status.idle": "2021-07-29T09:49:00.859317Z",
     "shell.execute_reply": "2021-07-29T09:49:00.861303Z"
     "duration": 1.027325,
     "end_time": "2021-07-29T09:49:00.861858",
     "start_time": "2021-07-29T09:48:59.834533",
     "status": "completed"
    },
    "tags": []
   },
   "outputs": [
    {
     "name": "stdout",
     "output_type": "stream",
     "text": [
      "theta_sat\n",
      "theta_res\n",
      "alpha\n",
      "n\n",
      "m\n",
      "S_mvg\n",
      "theta\n",
      "h\n",
      "S\n",
      "theta_4\n",
      "theta_3\n",
      "theta_2\n",
      "theta_1\n",
      "L\n",
      "Mw\n",
      "Pv\n",
      "Pvs\n",
      "R\n",
      "T\n",
      "c1\n",
      "T0\n",
      "Delta\n",
      "E\n",
      "G\n",
      "H\n",
      "Rn\n",
      "LE\n",
      "gamma\n",
      "alpha_PT\n",
      "c_p\n",
      "w\n",
      "kappa\n",
      "z\n",
      "u_star\n",
      "VH\n",
      "d\n",
      "z_om\n",
      "z_oh\n",
      "r_a\n",
      "g_a\n",
      "r_s\n",
      "g_s\n",
      "c1_e\n",
      "c2_e\n",
      "e\n",
      "T_min\n",
      "T_max\n",
      "RH_max\n",
      "RH_min\n",
      "e_a\n",
      "e_s\n",
      "iv_T\n",
      "T_kv\n",
      "P\n",
      "rho_a\n",
      "VPD\n"
     ]
    },
    {
     "name": "stdout",
     "output_type": "stream",
     "text": [
      "eq_m_n\n",
      "eq_MVG_neg_case\n",
      "eq_MVG\n",
      "eq_sat_degree\n",
      "eq_MVG_h\n",
      "eq_h_FC\n",
      "eq_theta_4_3\n",
      "eq_theta_2_1\n",
      "eq_water_stress_simple\n",
      "eq_Pvs_T\n",
      "eq_Delta\n",
      "eq_PT\n",
      "eq_PM\n",
      "eq_PM_VPD\n",
      "eq_PM_g\n",
      "eq_PM_inv\n"
     ]
    }
   ],
   "source": [
    "for code in [path_variable,path_equation]:\n",
    "    name_code = code[-20:-3]\n",
    "    spec = importlib.util.spec_from_file_location(name_code, code)\n",
    "    mod = importlib.util.module_from_spec(spec)\n",
    "    spec.loader.exec_module(mod)\n",
    "    names = getattr(mod, '__all__', [n for n in dir(mod) if not n.startswith('_')])\n",
    "    glob = globals()\n",
    "    for name in names:\n",
    "        print(name)\n",
    "        glob[name] = getattr(mod, name)"
   ]
  },
  {
   "cell_type": "markdown",
   "id": "incoming-choice",
     "duration": 0.068539,
     "end_time": "2021-07-29T09:49:01.021414",
     "start_time": "2021-07-29T09:49:00.952875",
     "status": "completed"
    },
    "tags": []
   },
   "source": [
    "## Importing the performance assessment functions defined in the analysis_function.py file"
   ]
  },
  {
   "cell_type": "code",
   "execution_count": 5,
   "id": "contemporary-cyprus",
     "iopub.execute_input": "2021-07-29T09:49:01.171696Z",
     "iopub.status.busy": "2021-07-29T09:49:01.171050Z",
     "iopub.status.idle": "2021-07-29T09:49:01.179678Z",
     "shell.execute_reply": "2021-07-29T09:49:01.178659Z"
     "duration": 0.10243,
     "end_time": "2021-07-29T09:49:01.179895",
     "start_time": "2021-07-29T09:49:01.077465",
     "status": "completed"
    },
    "tags": []
   },
   "outputs": [
    {
     "name": "stdout",
     "output_type": "stream",
     "text": [
      "AIC\n",
      "AME\n",
      "BIC\n",
      "CD\n",
      "CP\n",
      "IoA\n",
      "KGE\n",
      "MAE\n",
      "MARE\n",
      "ME\n",
      "MRE\n",
      "MSRE\n",
      "MdAPE\n",
      "NR4MS4E\n",
      "NRMSE\n",
      "NS\n",
      "NSC\n",
      "PDIFF\n",
      "PEP\n",
      "R4MS4E\n",
      "RAE\n",
      "RMSE\n",
      "np\n",
      "nt\n"
     ]
    }
   ],
   "source": [
    "for code in [path_analysis_functions]:\n",
    "    name_code = code[-20:-3]\n",
    "    spec = importlib.util.spec_from_file_location(name_code, code)\n",
    "    mod = importlib.util.module_from_spec(spec)\n",
    "    spec.loader.exec_module(mod)\n",
    "    names = getattr(mod, '__all__', [n for n in dir(mod) if not n.startswith('_')])\n",
    "    glob = globals()\n",
    "    for name in names:\n",
    "        print(name)\n",
    "        glob[name] = getattr(mod, name)"
   ]
  },
  {
   "cell_type": "markdown",
   "id": "finite-static",
     "duration": 0.05525,
     "end_time": "2021-07-29T09:49:01.296219",
     "start_time": "2021-07-29T09:49:01.240969",
     "status": "completed"
    },
    "tags": []
   },
   "source": [
    "## Data import, preprocess and shape for the computations"
   ]
  },
  {
   "cell_type": "markdown",
   "id": "equal-amplifier",
     "duration": 0.055749,
     "end_time": "2021-07-29T09:49:01.407322",
     "start_time": "2021-07-29T09:49:01.351573",
     "status": "completed"
    },
    "tags": []
   },
   "source": [
    "### Get the different files where data are stored\n",
    "\n",
    "Eddy-covariance data from the OzFlux network are stored in **.nc** files (NetCDF4 files) which is roughly a panda data frame with meta-data (see https://www.unidata.ucar.edu/software/netcdf/ for more details about NetCDF4 file format). fPAR data are stored in **.txt** files"
   ]
  },
  {
   "cell_type": "code",
   "execution_count": 6,
   "id": "finnish-application",
     "iopub.execute_input": "2021-07-29T09:49:01.524871Z",
     "iopub.status.busy": "2021-07-29T09:49:01.523938Z",
     "iopub.status.idle": "2021-07-29T09:49:01.532643Z",
     "shell.execute_reply": "2021-07-29T09:49:01.531764Z"
     "duration": 0.071089,
     "end_time": "2021-07-29T09:49:01.532879",
     "start_time": "2021-07-29T09:49:01.461790",
     "status": "completed"
    },
    "tags": []
   },
   "outputs": [
    {
     "name": "stdout",
     "output_type": "stream",
     "text": [
      "['data/eddycovdata/fpar_adelaide_v5.txt', 'data/eddycovdata/fpar_daly_v5.txt', 'data/eddycovdata/fpar_dry_v5.txt', 'data/eddycovdata/fpar_howard_v5.txt', 'data/eddycovdata/fpar_sturt_v5.txt']\n",
      "['data/eddycovdata/AdelaideRiver_L4.nc', 'data/eddycovdata/DalyUncleared_L4.nc', 'data/eddycovdata/DryRiver_L4.nc', 'data/eddycovdata/HowardSprings_L4.nc', 'data/eddycovdata/SturtPlains_L4.nc']\n"
     ]
    }
   ],
   "source": [
    "fPAR_files = []\n",
    "eddy_files = []\n",
    "\n",
    "for file in os.listdir(path_data):\n",
    "    if file.endswith(\".txt\"):\n",
    "        fPAR_files.append(os.path.join(path_data, file))\n",
    "    elif file.endswith(\".nc\"):\n",
    "        eddy_files.append(os.path.join(path_data, file))\n",
    "        \n",
    "fPAR_files.sort()\n",
    "print(fPAR_files)\n",
    "eddy_files.sort()\n",
    "print(eddy_files)"
   ]
  },
  {
   "cell_type": "markdown",
   "id": "sharp-artwork",
     "duration": 0.055904,
     "end_time": "2021-07-29T09:49:01.645065",
     "start_time": "2021-07-29T09:49:01.589161",
     "status": "completed"
    },
    "tags": []
   },
   "source": [
    "### Define and test a function that process the fPAR data\n",
    "In the **.txt** files, only one value per month is given for the fPAR. The following function takes one .txt file containing data about the fPAR coefficients, and the related dates, stored in the a seperate file. The fPAR data (date and coefficients) are cleaned (good string formatting), mapped together and averaged to output one value per month (the fPAR measurement period doesn't spans the measurement period of the eddy covariance data)"
   ]
  },
  {
   "cell_type": "code",
   "execution_count": 7,
   "id": "accepting-awareness",
     "iopub.execute_input": "2021-07-29T09:49:01.777204Z",
     "iopub.status.busy": "2021-07-29T09:49:01.769188Z",
     "iopub.status.idle": "2021-07-29T09:49:01.783176Z",
     "shell.execute_reply": "2021-07-29T09:49:01.782375Z"
     "duration": 0.082716,
     "end_time": "2021-07-29T09:49:01.783396",
     "start_time": "2021-07-29T09:49:01.700680",
     "status": "completed"
    },
    "tags": []
   },
   "outputs": [],
   "source": [
    "def fPAR_data_process(fPAR_file,dates_fPAR):\n",
    "    \n",
    "    fparv5_dates = np.genfromtxt(dates_fPAR, dtype='str', delimiter=',')\n",
    "    fparv5_dates = pd.to_datetime(fparv5_dates[:,1], format=\"%Y%m\")\n",
    "    dates_pd = pd.date_range(fparv5_dates[0], fparv5_dates[-1], freq='MS')\n",
    "\n",
    "    fparv5_howard = np.loadtxt(fPAR_file,delimiter=',', usecols=3 )\n",
    "    fparv5_howard[fparv5_howard == -999] = np.nan\n",
    "    fparv5_howard_pd = pd.Series(fparv5_howard, index = fparv5_dates)\n",
    "    fparv5_howard_pd = fparv5_howard_pd.resample('MS').max()\n",
    "\n",
    "    # convert fparv5_howard_pd to dataframe\n",
    "    fPAR_pd = pd.DataFrame(fparv5_howard_pd)\n",
    "    fPAR_pd = fPAR_pd.rename(columns={0:\"fPAR\"})\n",
    "    fPAR_pd.index = fPAR_pd.index.rename(\"time\")\n",
    "\n",
    "    # convert fPAR_pd to xarray to aggregate the data\n",
    "    fPAR_xr = fPAR_pd.to_xarray()\n",
    "    fPAR_agg = fPAR_xr.fPAR.groupby('time.month').max()\n",
    "\n",
    "    # convert back to dataframe\n",
    "    fPAR_pd = fPAR_agg.to_dataframe()\n",
    "    Month = np.arange(1,13)\n",
    "    Month_df = pd.DataFrame(Month)\n",
    "    Month_df.index = fPAR_pd.index\n",
    "    Month_df = Month_df.rename(columns={0:\"Month\"})\n",
    "\n",
    "    fPAR_mon = pd.concat([fPAR_pd,Month_df], axis = 1)\n",
    "    \n",
    "    return(fPAR_mon)"
   ]
  },
  {
   "cell_type": "code",
   "execution_count": 8,
   "id": "sticky-kidney",
     "iopub.execute_input": "2021-07-29T09:49:01.915731Z",
     "iopub.status.busy": "2021-07-29T09:49:01.915177Z",
     "iopub.status.idle": "2021-07-29T09:49:01.966125Z",
     "shell.execute_reply": "2021-07-29T09:49:01.967664Z"
     "duration": 0.117926,
     "end_time": "2021-07-29T09:49:01.968105",
     "start_time": "2021-07-29T09:49:01.850179",
     "status": "completed"
    },
    "tags": []
   },
   "outputs": [
    {
     "data": {
      "text/html": [
       "<div>\n",
       "<style scoped>\n",
       "    .dataframe tbody tr th:only-of-type {\n",
       "        vertical-align: middle;\n",
       "    }\n",
       "\n",
       "    .dataframe tbody tr th {\n",
       "        vertical-align: top;\n",
       "    }\n",
       "\n",
       "    .dataframe thead th {\n",
       "        text-align: right;\n",
       "    }\n",
       "</style>\n",
       "<table border=\"1\" class=\"dataframe\">\n",
       "  <thead>\n",
       "    <tr style=\"text-align: right;\">\n",
       "      <th></th>\n",
       "      <th>fPAR</th>\n",
       "      <th>Month</th>\n",
       "    </tr>\n",
       "    <tr>\n",
       "      <th>month</th>\n",
       "      <th></th>\n",
       "      <th></th>\n",
       "    </tr>\n",
       "  </thead>\n",
       "  <tbody>\n",
       "    <tr>\n",
       "      <th>1</th>\n",
       "      <td>0.78</td>\n",
       "      <td>1</td>\n",
       "    </tr>\n",
       "    <tr>\n",
       "      <th>2</th>\n",
       "      <td>0.84</td>\n",
       "      <td>2</td>\n",
       "    </tr>\n",
       "    <tr>\n",
       "      <th>3</th>\n",
       "      <td>0.79</td>\n",
       "      <td>3</td>\n",
       "    </tr>\n",
       "    <tr>\n",
       "      <th>4</th>\n",
       "      <td>0.84</td>\n",
       "      <td>4</td>\n",
       "    </tr>\n",
       "    <tr>\n",
       "      <th>5</th>\n",
       "      <td>0.71</td>\n",
       "      <td>5</td>\n",
       "    </tr>\n",
       "    <tr>\n",
       "      <th>6</th>\n",
       "      <td>0.75</td>\n",
       "      <td>6</td>\n",
       "    </tr>\n",
       "    <tr>\n",
       "      <th>7</th>\n",
       "      <td>0.60</td>\n",
       "      <td>7</td>\n",
       "    </tr>\n",
       "    <tr>\n",
       "      <th>8</th>\n",
       "      <td>0.54</td>\n",
       "      <td>8</td>\n",
       "    </tr>\n",
       "    <tr>\n",
       "      <th>9</th>\n",
       "      <td>0.52</td>\n",
       "      <td>9</td>\n",
       "    </tr>\n",
       "    <tr>\n",
       "      <th>10</th>\n",
       "      <td>0.67</td>\n",
       "      <td>10</td>\n",
       "    </tr>\n",
       "    <tr>\n",
       "      <th>11</th>\n",
       "      <td>0.73</td>\n",
       "      <td>11</td>\n",
       "    </tr>\n",
       "    <tr>\n",
       "      <th>12</th>\n",
       "      <td>0.78</td>\n",
       "      <td>12</td>\n",
       "    </tr>\n",
       "  </tbody>\n",
       "</table>\n",
       "</div>"
      ],
      "text/plain": [
       "       fPAR  Month\n",
       "month             \n",
       "1      0.78      1\n",
       "2      0.84      2\n",
       "3      0.79      3\n",
       "4      0.84      4\n",
       "5      0.71      5\n",
       "6      0.75      6\n",
       "7      0.60      7\n",
       "8      0.54      8\n",
       "9      0.52      9\n",
       "10     0.67     10\n",
       "11     0.73     11\n",
       "12     0.78     12"
      ]
     },
     "execution_count": 8,
     "metadata": {},
     "output_type": "execute_result"
    }
   ],
   "source": [
    "fPAR_data_process(fPAR_files[3],dates_fPAR)"
   ]
  },
  {
   "cell_type": "markdown",
   "id": "fatty-gross",
     "duration": 0.059125,
     "end_time": "2021-07-29T09:49:02.099159",
     "start_time": "2021-07-29T09:49:02.040034",
     "status": "completed"
    },
    "tags": []
   },
   "source": [
    "### fPARSet function\n",
    "Map the fPAR time serie to the given eddy-covariance data. Takes two dataframes as input (one containing the fPAR data, the other containing the eddy-covariance data) and returns a data frame where the fPAR monthly values have been scaled to the time scale of the eddy covariance data"
   ]
  },
  {
   "cell_type": "code",
   "execution_count": 9,
   "id": "corporate-preference",
     "iopub.execute_input": "2021-07-29T09:49:02.269289Z",
     "iopub.status.busy": "2021-07-29T09:49:02.268650Z",
     "iopub.status.idle": "2021-07-29T09:49:02.273818Z",
     "shell.execute_reply": "2021-07-29T09:49:02.272943Z"
     "duration": 0.116033,
     "end_time": "2021-07-29T09:49:02.274017",
     "start_time": "2021-07-29T09:49:02.157984",
     "status": "completed"
    },
    "tags": []
   },
   "outputs": [],
   "source": [
    "def fPARSet(df_add, fPAR_pd):\n",
    "    \n",
    "    # construct the time serie of the fPAR coefficients\n",
    "    dummy_len = df_add[\"Fe\"].size\n",
    "    fPAR_val = np.zeros((dummy_len,))\n",
    "    \n",
    "    dummy_pd = df_add\n",
    "    dummy_pd.reset_index(inplace=True)\n",
    "    dummy_pd.index=dummy_pd.time\n",
    "    \n",
    "    month_pd = dummy_pd['time'].dt.month\n",
    "    \n",
    "    for i in range(dummy_len):\n",
    "        current_month = month_pd.iloc[i]\n",
    "        line_fPAR = fPAR_pd[fPAR_pd['Month'] == current_month]\n",
    "        fPAR_val[i] = line_fPAR['fPAR']\n",
    "    \n",
    "    # transform fPAR_val into dataframe to concatenate to df:\n",
    "    fPAR = pd.DataFrame(fPAR_val, index = df_add.index)\n",
    "    df_add = pd.concat([df_add,fPAR], axis = 1)\n",
    "    df_add = df_add.rename(columns = {0:\"fPAR\"})\n",
    "    \n",
    "    return(df_add)"
   ]
  },
  {
   "cell_type": "markdown",
   "id": "confused-arnold",
     "duration": 0.05981,
     "end_time": "2021-07-29T09:49:02.397755",
     "start_time": "2021-07-29T09:49:02.337945",
     "status": "completed"
    },
    "tags": []
   },
   "source": [
    "### DataChose function\n",
    "\n",
    "Function taking the raw netcdf4 data file from the eddy covariance measurement and shape it such that it can be used for the computations. Only relevant variables are kept (latent heat flux, net radiation, ground heat flux, soil water content, wind speed, air temperature, VPD, bed shear stress). The desired data period is selected and is reshaped at the desired time scale (daily by default). Uses the fPARSet function defined above\n",
    "\n",
    "List of variable abbreviation : \n",
    "* `Rn` : Net radiation flux\n",
    "* `G` : Ground heat flux \n",
    "* `Sws` : soil moisture\n",
    "* `Ta` : Air temperature\n",
    "* `RH` : Relative humidity\n",
    "* `W` : Wind speed\n",
    "* `E` : measured evaporation\n",
    "* `VPD` : Vapour pressure deficit"
   ]
  },
  {
   "cell_type": "code",
   "execution_count": 10,
   "id": "increasing-jewelry",
     "iopub.execute_input": "2021-07-29T09:49:02.539635Z",
     "iopub.status.busy": "2021-07-29T09:49:02.538732Z",
     "iopub.status.idle": "2021-07-29T09:49:02.544322Z",
     "shell.execute_reply": "2021-07-29T09:49:02.542633Z"
     "duration": 0.083843,
     "end_time": "2021-07-29T09:49:02.544725",
     "start_time": "2021-07-29T09:49:02.460882",
     "status": "completed"
    },
    "tags": []
   },
   "outputs": [],
   "source": [
    "def DataChose(ds_ref, period_sel, fPAR_given, Freq = \"D\", sel_period_flag = True):\n",
    "    \"\"\"Take subset of dataset if Flag == True, entire dataset else\n",
    "    \n",
    "    ds_ref: xarray object to be considered as the ref for selecting attributes\n",
    "    agg_flag: aggregate the data at daily time scale if true\n",
    "    Flag: select specific period if true (by default)\n",
    "    period: time period to be selected\n",
    "    ----------\n",
    "    Method : \n",
    "    - transform the xarray in panda dataframe for faster iteration\n",
    "    - keep only the necessary columns : Fe, Fn, Fg, Ws, Sws, Ta, ustar, RH\n",
    "    - transform / create new variables : Temperature in °C, T_min/T_max, RH_min/RH_max\n",
    "    - create the Data vector (numpy arrays)\n",
    "    - create back a xarray \n",
    "    - return an xarray\n",
    "    ----------\n",
    "    \n",
    "    Returns an xarray and a Data vector\n",
    "    \"\"\"\n",
    "    \n",
    "    if sel_period_flag:\n",
    "        df = ds_ref.sel(time = period_sel) \n",
    "        # nameXarray_output = period + \"_\" + nameXarray_output\n",
    "    else : \n",
    "        df = ds_ref\n",
    "        \n",
    "    # keep only the columns of interest\n",
    "    df = df[[\"Fe\",\"Fn\",\"Fg\",\"Ws\",\"Sws\",\"Ta\",\"ustar\",\"RH\", \"VPD\",\"ps\"]]\n",
    "    \n",
    "    # convert to dataframe\n",
    "    df = df.to_dataframe()\n",
    "    \n",
    "    # aggregate following the rule stated in freq\n",
    "    pd_Tmin = df.Ta.groupby([pd.Grouper(level = \"latitude\"), pd.Grouper(level = \"longitude\"), pd.Grouper(level = \"time\", freq = Freq)]).min()\n",