diff --git a/notebooks/Gotthard2/Correction_Gotthard2_NBC.ipynb b/notebooks/Gotthard2/Correction_Gotthard2_NBC.ipynb
index db677fcd6f152498daaf73b5fad0808966fe9012..157dac917a944416dc41368d73dc0a14ca892a76 100644
--- a/notebooks/Gotthard2/Correction_Gotthard2_NBC.ipynb
+++ b/notebooks/Gotthard2/Correction_Gotthard2_NBC.ipynb
@@ -36,10 +36,9 @@
     "karabo_id_control = \"\"  # Control karabo ID. Set to empty string to use the karabo-id\n",
     "\n",
     "# Parameters for calibration database.\n",
-    "use_dir_creation_date = True  # use the creation data of the input dir for database queries.\n",
     "cal_db_interface = \"tcp://max-exfl016:8016#8025\"  # the database interface to use.\n",
     "cal_db_timeout = 180000  # timeout on caldb requests.\n",
-    "overwrite_creation_time = \"\"  # To overwrite the measured creation_time. Required Format: YYYY-MM-DD HR:MN:SC.00 e.g. \"2022-06-28 13:00:00.00\"\n",
+    "creation_time = \"\"  # To overwrite the measured creation_time. Required Format: YYYY-MM-DD HR:MN:SC e.g. \"2022-06-28 13:00:00\"\n",
     "\n",
     "# Parameters affecting corrected data.\n",
     "constants_file = \"\"  # Use constants in given constant file path. /gpfs/exfel/data/scratch/ahmedk/dont_remove/gotthard2/constants/calibration_constants_GH2.h5\n",
@@ -71,8 +70,8 @@
    "metadata": {},
    "outputs": [],
    "source": [
-    "import datetime\n",
     "import warnings\n",
+    "from logging import warning\n",
     "\n",
     "import h5py\n",
     "import pasha as psh\n",
@@ -82,16 +81,15 @@
     "from extra_data import RunDirectory, H5File\n",
     "from pathlib import Path\n",
     "\n",
+    "import cal_tools.restful_config as rest_cfg\n",
+    "from cal_tools.calcat_interface import CalCatError, GOTTHARD2_CalibrationData\n",
     "from cal_tools.files import DataFile\n",
     "from cal_tools.gotthard2 import gotthard2algs, gotthard2lib\n",
     "from cal_tools.step_timing import StepTimer\n",
     "from cal_tools.tools import (\n",
-    "    get_constant_from_db_and_time,\n",
-    "    get_dir_creation_date,\n",
-    "    get_pdu_from_db,\n",
+    "    calcat_creation_time,\n",
     "    CalibrationMetadata,\n",
     ")\n",
-    "from iCalibrationDB import Conditions, Constants\n",
     "from XFELDetAna.plotting.heatmap import heatmapPlot\n",
     "\n",
     "warnings.filterwarnings('ignore')\n",
@@ -123,14 +121,9 @@
     "\n",
     "print(f\"Process modules: {karabo_da} for run {run}\")\n",
     "\n",
-    "creation_time = None\n",
-    "if overwrite_creation_time:\n",
-    "    creation_time = datetime.datetime.strptime(\n",
-    "        overwrite_creation_time, \"%Y-%m-%d %H:%M:%S.%f\"\n",
-    "    )\n",
-    "elif use_dir_creation_date:\n",
-    "    creation_time = get_dir_creation_date(in_folder, run)\n",
-    "    print(f\"Using {creation_time} as creation time\")"
+    "# Run's creation time:\n",
+    "creation_time = calcat_creation_time(in_folder, run, creation_time)\n",
+    "print(f\"Creation time: {creation_time}\")"
    ]
   },
   {
@@ -215,90 +208,99 @@
    "metadata": {},
    "outputs": [],
    "source": [
+    "da_to_pdu = {}\n",
     "# Used for old FXE (p003225) runs before adding Gotthard2 to CALCAT\n",
     "const_data = dict()\n",
-    "if constants_file:\n",
-    "    for mod in karabo_da:\n",
-    "        const_data[mod] = dict()\n",
-    "        # load constants temporarily using defined local paths.\n",
-    "        with h5py.File(constants_file, \"r\") as cfile:\n",
-    "            const_data[mod][\"LUT\"] = cfile[\"LUT\"][()]\n",
-    "            const_data[mod][\"Offset\"] = cfile[\"offset_map\"][()].astype(np.float32)\n",
-    "            const_data[mod][\"RelativeGain\"] = cfile[\"gain_map\"][()].astype(np.float32)\n",
-    "            const_data[mod][\"Mask\"] = cfile[\"bpix_ff\"][()].astype(np.uint32)"
-   ]
-  },
-  {
-   "cell_type": "code",
-   "execution_count": null,
-   "id": "1cdbe818",
-   "metadata": {},
-   "outputs": [],
-   "source": [
-    "# Conditions iCalibrationDB object.\n",
-    "condition = Conditions.Dark.Gotthard2(\n",
-    "    bias_voltage=bias_voltage,\n",
+    "\n",
+    "g2_cal = GOTTHARD2_CalibrationData(\n",
+    "    detector_name=karabo_id,\n",
+    "    sensor_bias_voltage=bias_voltage,\n",
     "    exposure_time=exposure_time,\n",
     "    exposure_period=exposure_period,\n",
-    "    single_photon=single_photon,\n",
     "    acquisition_rate=acquisition_rate,\n",
+    "    single_photon=single_photon,\n",
+    "    event_at=creation_time,\n",
+    "    client=rest_cfg.calibration_client(),\n",
     ")\n",
+    "# Keep as long as it is essential to correct\n",
+    "# RAW data (FXE p003225) before the data mapping was added to CALCAT.\n",
+    "try:  # in case local constants are used with old RAW data. This can be removed in the future.\n",
+    "    for mod_info in g2_cal.physical_detector_units.values():\n",
+    "        da_to_pdu[mod_info[\"karabo_da\"]] = mod_info[\"physical_name\"]\n",
+    "    db_modules = [da_to_pdu[da] for da in karabo_da]\n",
+    "except CalCatError as e:\n",
+    "    print(e)\n",
+    "    db_modules = [None] * len(karabo_da)\n",
     "\n",
-    "# TODO: Maybe this condition and previous cell can be removed later after the initial phase.\n",
-    "if not constants_file:\n",
-    "    # Prepare a dictionary of empty constants to loop on\n",
-    "    # it's keys and initiate non-retrieved constants.\n",
-    "    empty_lut = (np.arange(2 ** 12).astype(np.float64) * 2 ** 10 / 2 ** 12).astype(\n",
-    "        np.uint16\n",
-    "    )\n",
-    "    empty_lut = np.stack(1280 * [np.stack([empty_lut] * 2)], axis=0)\n",
-    "    empty_constants = {\n",
-    "        \"LUT\": empty_lut,\n",
-    "        \"Offset\": np.zeros((1280, 2, 3), dtype=np.float32),\n",
-    "        \"BadPixelsDark\": np.zeros((1280, 2, 3), dtype=np.uint32),\n",
-    "        \"RelativeGain\": np.ones((1280, 2, 3), dtype=np.float32),\n",
-    "        \"BadPixelsFF\": np.zeros((1280, 2, 3), dtype=np.uint32),\n",
-    "    }\n",
-    "\n",
+    "if constants_file:\n",
     "    for mod in karabo_da:\n",
     "        const_data[mod] = dict()\n",
-    "        # Only used for printing timestamps within the loop.\n",
-    "        when = dict()\n",
-    "        # Check YAML file for constant metadata of file path and creation-time\n",
-    "        if const_yaml:\n",
+    "        # load constants temporarily using defined local paths.\n",
+    "        with h5py.File(constants_file, \"r\") as cfile:\n",
+    "            const_data[mod][\"LUTGotthard2\"] = cfile[\"LUT\"][()]\n",
+    "            const_data[mod][\"OffsetGotthard2\"] = cfile[\"offset_map\"][()].astype(np.float32)\n",
+    "            const_data[mod][\"RelativeGainGotthard2\"] = cfile[\"gain_map\"][()].astype(np.float32)\n",
+    "            const_data[mod][\"Mask\"] = cfile[\"bpix_ff\"][()].astype(np.uint32)\n",
+    "else:\n",
+    "    if const_yaml:\n",
+    "        const_data = dict()\n",
+    "        for mod in karabo_da:\n",
+    "            const_data[mod] = dict()\n",
     "            for cname, mdata in const_yaml[mod][\"constants\"].items():\n",
     "                const_data[mod][cname] = dict()\n",
-    "                when[cname] = mdata[\"creation-time\"]\n",
-    "                if when[cname]:\n",
-    "                    with h5py.File(mdata[\"file-path\"], \"r\") as cf:\n",
+    "                if mdata[\"creation-time\"]:\n",
+    "                    with h5py.File(mdata[\"path\"], \"r\") as cf:\n",
     "                        const_data[mod][cname] = np.copy(\n",
-    "                            cf[f\"{mdata['dataset-name']}/data\"]\n",
-    "                        )\n",
-    "                else:\n",
-    "                    const_data[mod][cname] = empty_constants[cname]\n",
-    "        else:  # Retrieve constants from CALCAT. Missing YAML file or running notebook interactively.\n",
-    "            for cname, cempty in empty_constants.items():\n",
-    "                const_data[mod][cname] = dict()\n",
-    "                const_data[mod][cname], when[cname] = get_constant_from_db_and_time(\n",
-    "                    karabo_id=karabo_id,\n",
-    "                    karabo_da=mod,\n",
-    "                    cal_db_interface=cal_db_interface,\n",
-    "                    creation_time=creation_time,\n",
-    "                    timeout=cal_db_timeout,\n",
-    "                    print_once=False,\n",
-    "                    condition=condition,\n",
-    "                    constant=getattr(Constants.Gotthard2, cname)(),\n",
-    "                    empty_constant=cempty,\n",
-    "                )\n",
-    "        bpix = const_data[mod][\"BadPixelsDark\"]\n",
-    "        bpix |= const_data[mod][\"BadPixelsFF\"]\n",
+    "                            cf[f\"{mdata['dataset']}/data\"])\n",
+    "    else:\n",
+    "        mdata_dict = {\"constants\": dict()}\n",
+    "\n",
+    "        constant_names = [\"LUTGotthard2\", \"OffsetGotthard2\", \"BadPixelsDarkGotthard2\"]\n",
+    "        if gain_correction:\n",
+    "            constant_names += [\"RelativeGainGotthard2\", \"BadPixelsFFGotthard2\"]\n",
+    "\n",
+    "        # Retrieve metadata for all pnccd constants.\n",
+    "        const_data = g2_cal.ndarray_map(constant_names)\n",
+    "\n",
+    "    # Validate the constants availability and raise/warn correspondingly.\n",
+    "    for mod, calibrations in const_data.items():\n",
+    "\n",
+    "        dark_constants = {\"LUTGotthard2\"}\n",
+    "        if offset_correction:\n",
+    "            dark_constants |= {\"OffsetGotthard2\", \"BadPixelsDarkGotthard2\"}\n",
+    "\n",
+    "        missing_dark_constants = dark_constants - set(calibrations)\n",
+    "        if missing_dark_constants:\n",
+    "            karabo_da.remove(mod)\n",
+    "            warning(f\"Dark constants {missing_dark_constants} are not available to correct {mod}.\")  # noqa\n",
+    "\n",
+    "        missing_gain_constants = {\n",
+    "            \"BadPixelsFFGotthard2\", \"RelativeGainGotthard2\"} - set(calibrations)\n",
+    "        if gain_correction and missing_gain_constants:\n",
+    "            warning(f\"Gain constants {missing_gain_constants} are not retrieved for mod {mod}.\"\n",
+    "                    \"Gain correction is disabled for this module\")\n",
+    "\n",
+    "        # Create the mask array.\n",
+    "        bpix = const_data[mod].get(\"BadPixelsDarkGotthard2\")\n",
+    "        if bpix is None:\n",
+    "            bpix = np.zeros((1280, 2, 3), dtype=np.uint32)\n",
+    "        if const_data[mod].get(\"BadPixelsFFGotthard2\") is not None:\n",
+    "            bpix |= const_data[mod][\"BadPixelsFFGotthard2\"]\n",
     "        const_data[mod][\"Mask\"] = bpix\n",
     "\n",
-    "        # Print timestamps for the retrieved constants.\n",
-    "        print(f\"Constants for module {mod}:\")\n",
-    "        for cname, ctime in when.items():\n",
-    "            print(f\"  {cname} injected at {ctime}\")\n",
-    "        del when"
+    "        # Prepare empty arrays for missing constants.\n",
+    "        if const_data[mod].get(\"OffsetGotthard2\") is None:\n",
+    "            const_data[mod][\"OffsetGotthard2\"] = np.zeros(\n",
+    "                (1280, 2, 3), dtype=np.float32)\n",
+    "\n",
+    "        if const_data[mod].get(\"RelativeGainGotthard2\") is None:\n",
+    "            const_data[mod][\"RelativeGainGotthard2\"] = np.ones(\n",
+    "                (1280, 2, 3), dtype=np.float32)\n",
+    "        const_data[mod][\"RelativeGainGotthard2\"] = const_data[mod][\"RelativeGainGotthard2\"].astype(  # noqa\n",
+    "            np.float32, copy=False)  # Old gain constants are not float32.\n",
+    "\n",
+    "if not karabo_da:\n",
+    "    raise ValueError(\"Dark constants are not available for all modules.\")"
    ]
   },
   {
@@ -320,13 +322,13 @@
    "source": [
     "def correct_train(wid, index, d):\n",
     "    g = gain[index]\n",
-    "    gotthard2algs.convert_to_10bit(d, const_data[mod][\"LUT\"], data_corr[index, ...])\n",
+    "    gotthard2algs.convert_to_10bit(d, const_data[mod][\"LUTGotthard2\"], data_corr[index, ...])\n",
     "    gotthard2algs.correct_train(\n",
     "        data_corr[index, ...],\n",
     "        mask[index, ...],\n",
     "        g,\n",
-    "        const_data[mod][\"Offset\"],\n",
-    "        const_data[mod][\"RelativeGain\"].astype(np.float32, copy=False),\n",
+    "        const_data[mod][\"OffsetGotthard2\"],\n",
+    "        const_data[mod][\"RelativeGainGotthard2\"],  \n",
     "        const_data[mod][\"Mask\"],\n",
     "        apply_offset=offset_correction,\n",
     "        apply_gain=gain_correction,\n",
@@ -464,32 +466,6 @@
     "        mod_dcs[mod][\"train_raw_gain\"] = train_dict[\"data.gain\"]"
    ]
   },
-  {
-   "cell_type": "code",
-   "execution_count": null,
-   "id": "494b453a",
-   "metadata": {},
-   "outputs": [],
-   "source": [
-    "# Keep as long as it is essential to correct\n",
-    "# RAW data (FXE p003225) before the data mapping was added to CALCAT.\n",
-    "try:\n",
-    "    db_modules = get_pdu_from_db(\n",
-    "        karabo_id=karabo_id,\n",
-    "        karabo_da=karabo_da,\n",
-    "        constant=Constants.jungfrau.Offset(),\n",
-    "        condition=condition,\n",
-    "        cal_db_interface=cal_db_interface,\n",
-    "        snapshot_at=creation_time,\n",
-    "    )\n",
-    "except RuntimeError:\n",
-    "    print(\n",
-    "        \"No Physical detector units found for this\"\n",
-    "        \" detector mapping at the RAW data creation time.\"\n",
-    "    )\n",
-    "    db_modules = [None] * len(karabo_da)"
-   ]
-  },
   {
    "cell_type": "code",
    "execution_count": null,
diff --git a/notebooks/Gotthard2/Gotthard2_retrieve_constants_precorrection_NBC.ipynb b/notebooks/Gotthard2/Gotthard2_retrieve_constants_precorrection_NBC.ipynb
index 18aa31302652bcbef11897c2b665083d08380218..679bc8506b03f887e077be4993ae63aeee29b0c3 100644
--- a/notebooks/Gotthard2/Gotthard2_retrieve_constants_precorrection_NBC.ipynb
+++ b/notebooks/Gotthard2/Gotthard2_retrieve_constants_precorrection_NBC.ipynb
@@ -32,13 +32,12 @@
     "karabo_id_control = \"\"  # Control karabo ID. Set to empty string to use the karabo-id\n",
     "\n",
     "# Parameters for calibration database.\n",
-    "use_dir_creation_date = True  # use the creation data of the input dir for database queries.\n",
-    "cal_db_interface = \"tcp://max-exfl017:8017#8025\"  # the database interface to use.\n",
+    "cal_db_interface = \"tcp://max-exfl016:8017#8025\"  # the database interface to use.\n",
     "cal_db_timeout = 180000  # timeout on caldb requests.\n",
-    "overwrite_creation_time = \"2022-06-28 13:00:00.00\"  # To overwrite the measured creation_time. Required Format: YYYY-MM-DD HR:MN:SC.00 e.g. \"2022-06-28 13:00:00.00\"\n",
+    "creation_time = \"\"  # To overwrite the measured creation_time. Required Format: YYYY-MM-DD HR:MN:SC e.g. \"2022-06-28 13:00:00\"\n",
     "\n",
     "# Parameters affecting corrected data.\n",
-    "constants_file = \"\"#/gpfs/exfel/data/scratch/ahmedk/dont_remove/gotthard2/constants/calibration_constants_GH2.h5\"  # Retrieve constants from local.\n",
+    "constants_file = \"\"  # /gpfs/exfel/data/scratch/ahmedk/dont_remove/gotthard2/constants/calibration_constants_GH2.h5\"  # Retrieve constants from local.\n",
     "offset_correction = True  # apply offset correction. This can be disabled to only apply LUT or apply LUT and gain correction for non-linear differential results.\n",
     "gain_correction = True  # apply gain correction.\n",
     "\n",
@@ -46,8 +45,8 @@
     "bias_voltage = -1  # Detector bias voltage, set to -1 to use value in raw file.\n",
     "exposure_time = -1.  # Detector exposure time, set to -1 to use value in raw file.\n",
     "exposure_period = -1.  # Detector exposure period, set to -1 to use value in raw file.\n",
-    "acquisition_rate = 1.1  # Detector acquisition rate (1.1/4.5), set to -1 to use value in raw file.\n",
-    "single_photon = 0  # Detector single photon mode (High/Low CDS), set to -1 to use value in raw file.\n",
+    "acquisition_rate = -1.  # Detector acquisition rate (1.1/4.5), set to -1 to use value in raw file.\n",
+    "single_photon = -1  # Detector single photon mode (High/Low CDS), set to -1 to use value in raw file.\n",
     "\n",
     "if constants_file:\n",
     "    print(\"Skipping constant retrieval. Specified constants_file is used.\")\n",
@@ -62,20 +61,18 @@
    "metadata": {},
    "outputs": [],
    "source": [
-    "import datetime\n",
-    "from functools import partial\n",
+    "from logging import warning\n",
     "\n",
-    "import multiprocessing\n",
     "from extra_data import RunDirectory\n",
     "from pathlib import Path\n",
     "\n",
+    "import cal_tools.restful_config as rest_cfg\n",
+    "from cal_tools.calcat_interface import GOTTHARD2_CalibrationData\n",
     "from cal_tools.gotthard2 import gotthard2lib\n",
     "from cal_tools.tools import (\n",
-    "    get_dir_creation_date,\n",
-    "    get_from_db,\n",
+    "    calcat_creation_time,\n",
     "    CalibrationMetadata,\n",
-    ")\n",
-    "from iCalibrationDB import Conditions, Constants"
+    ")"
    ]
   },
   {
@@ -89,6 +86,8 @@
     "out_folder = Path(out_folder)\n",
     "out_folder.mkdir(parents=True, exist_ok=True)\n",
     "metadata = CalibrationMetadata(metadata_folder or out_folder)\n",
+    "# Constant paths are saved under retrieved-constants in calibration_metadata.yml\n",
+    "retrieved_constants = metadata.setdefault(\"retrieved-constants\", {})\n",
     "\n",
     "if not karabo_id_control:\n",
     "    karabo_id_control = karabo_id\n",
@@ -98,14 +97,9 @@
     "\n",
     "print(f\"Retrieve constants for modules: {karabo_da} for run {run}\")\n",
     "\n",
-    "creation_time = None\n",
-    "if overwrite_creation_time:\n",
-    "    creation_time = datetime.datetime.strptime(\n",
-    "        overwrite_creation_time, \"%Y-%m-%d %H:%M:%S.%f\"\n",
-    "    )\n",
-    "elif use_dir_creation_date:\n",
-    "    creation_time = get_dir_creation_date(in_folder, run)\n",
-    "    print(f\"Using {creation_time} as creation time\")"
+    "# Run's creation time:\n",
+    "creation_time = calcat_creation_time(in_folder, run, creation_time)\n",
+    "print(f\"Creation time: {creation_time}\")"
    ]
   },
   {
@@ -142,60 +136,60 @@
    "metadata": {},
    "outputs": [],
    "source": [
-    "condition = Conditions.Dark.Gotthard2(\n",
-    "    bias_voltage=bias_voltage,\n",
+    "g2_cal = GOTTHARD2_CalibrationData(\n",
+    "    detector_name=karabo_id,\n",
+    "    sensor_bias_voltage=bias_voltage,\n",
     "    exposure_time=exposure_time,\n",
     "    exposure_period=exposure_period,\n",
-    "    single_photon=single_photon,\n",
     "    acquisition_rate=acquisition_rate,\n",
+    "    single_photon=single_photon,\n",
+    "    event_at=creation_time,\n",
+    "    client=rest_cfg.calibration_client(),\n",
     ")\n",
     "\n",
-    "def get_constants_for_module(mod: str):\n",
-    "    \"\"\"Get calibration constants for given module for Gotthard2.\"\"\"\n",
-    "    retrieval_function = partial(\n",
-    "        get_from_db,\n",
-    "        karabo_id=karabo_id,\n",
-    "        karabo_da=mod,\n",
-    "        cal_db_interface=cal_db_interface,\n",
-    "        creation_time=creation_time,\n",
-    "        timeout=cal_db_timeout,\n",
-    "        verbosity=1,\n",
-    "        meta_only=True,\n",
-    "        load_data=False,\n",
-    "        empty_constant=None\n",
-    "    )\n",
-    "\n",
-    "    mdata_dict = dict()\n",
-    "    mdata_dict[\"constants\"] = dict()\n",
-    "    constants = [\n",
-    "        \"LUT\", \"Offset\", \"BadPixelsDark\",\n",
-    "        \"RelativeGain\", \"BadPixelsFF\",\n",
-    "    ]\n",
-    "    for cname in constants:\n",
-    "        mdata_dict[\"constants\"][cname] = dict()\n",
-    "        if not gain_correction and cname in [\"BadPixelsFF\", \"RelativeGain\"]:\n",
-    "            continue\n",
-    "        _, mdata = retrieval_function(\n",
-    "            condition=condition,\n",
-    "            constant=getattr(Constants.Gotthard2, cname)(),\n",
-    "        )\n",
-    "        mdata_const = mdata.calibration_constant_version\n",
-    "        const_mdata = mdata_dict[\"constants\"][cname]\n",
-    "        # check if constant was successfully retrieved.\n",
-    "        if mdata.comm_db_success:\n",
-    "            const_mdata[\"file-path\"] = (\n",
-    "                f\"{mdata_const.hdf5path}\" f\"{mdata_const.filename}\"\n",
-    "            )\n",
-    "            const_mdata[\"dataset-name\"] = mdata_const.h5path\n",
-    "            const_mdata[\"creation-time\"] = f\"{mdata_const.begin_at}\"\n",
-    "            mdata_dict[\"physical-detector-unit\"] = mdata_const.device_name\n",
-    "        else:\n",
-    "            const_mdata[\"file-path\"] = None\n",
-    "            const_mdata[\"creation-time\"] = None\n",
-    "    return mdata_dict, mod\n",
-    "\n",
-    "with multiprocessing.Pool() as pool:\n",
-    "    results = pool.map(get_constants_for_module, karabo_da)"
+    "mdata_dict = {\"constants\": dict()}\n",
+    "\n",
+    "constant_names = [\"LUTGotthard2\", \"OffsetGotthard2\", \"BadPixelsDarkGotthard2\"]\n",
+    "if gain_correction:\n",
+    "    constant_names += [\"RelativeGainGotthard2\", \"BadPixelsFFGotthard2\"]\n",
+    "\n",
+    "# Retrieve metadata for all pnccd constants.\n",
+    "g2_metadata = g2_cal.metadata(constant_names)\n",
+    "\n",
+    "missing_dark_modules = set()\n",
+    "# Validate the constants availability and raise/warn correspondingly.\n",
+    "for mod, ccv_dict in g2_metadata.items():\n",
+    "\n",
+    "    dark_constants = {\"LUTGotthard2\"}\n",
+    "    if offset_correction:\n",
+    "        dark_constants |= {\"OffsetGotthard2\", \"BadPixelsDarkGotthard2\"}\n",
+    "    missing_dark_constants = dark_constants - set(ccv_dict)\n",
+    "\n",
+    "    if missing_dark_constants:\n",
+    "        warning(f\"Dark constants {missing_dark_constants} are not available to correct {mod}\")\n",
+    "        missing_dark_modules.add(mod)\n",
+    "\n",
+    "    missing_gain_constants = {\"BadPixelsFFGotthard2\", \"RelativeGainGotthard2\"} - set(ccv_dict)\n",
+    "    if gain_correction and missing_gain_constants:\n",
+    "        warning(f\"Gain constants {missing_gain_constants} are not retrieved for {mod}\")\n",
+    "\n",
+    "if missing_dark_modules == set(karabo_da):\n",
+    "    raise ValueError(f\"{missing_dark_constants} constants are not available for all modules.\")\n",
+    "\n",
+    "# Add constants metadata in retrieved_constants dict.\n",
+    "for mod, ccv_dict in g2_metadata.items():\n",
+    "    mod_dict = retrieved_constants.setdefault(mod, dict())\n",
+    "    const_dict = mod_dict.setdefault(\"constants\", dict())\n",
+    "    for cname, ccv_metadata in ccv_dict.items():\n",
+    "        const_dict[cname] = {\n",
+    "                \"path\": str(g2_cal.caldb_root / ccv_metadata[\"path\"]),\n",
+    "                \"dataset\": ccv_metadata[\"dataset\"],\n",
+    "                \"creation-time\": ccv_metadata[\"begin_validity_at\"],\n",
+    "                \"ccv_id\": ccv_metadata[\"ccv_id\"],\n",
+    "            }\n",
+    "    mod_dict[\"physical-name\"] = ccv_metadata[\"physical_name\"]\n",
+    "    \n",
+    "print(f\"Stored retrieved constants in {metadata.filename}\")"
    ]
   },
   {
@@ -204,31 +198,22 @@
    "metadata": {},
    "outputs": [],
    "source": [
-    "# Constant paths are saved under retrieved-constants in calibration_metadata.yml\n",
-    "retrieved_constants = metadata.setdefault(\"retrieved-constants\", {})\n",
     "timestamps = dict()\n",
     "\n",
-    "for md_dict, mod in results:\n",
-    "    if mod in retrieved_constants:\n",
-    "        print(f\"Constant for {mod} already in calibration_metadata.yml, won't query again.\")  # noqa\n",
-    "        continue\n",
-    "    retrieved_constants[mod] = md_dict\n",
+    "for mod in karabo_da:\n",
     "    module_timestamps = timestamps[mod] = dict()\n",
-    "\n",
+    "    module_constants = retrieved_constants[mod]\n",
     "    print(f\"Module: {mod}:\")\n",
-    "    for cname, mdata in md_dict[\"constants\"].items():\n",
-    "        if hasattr(mdata[\"creation-time\"], 'strftime'):\n",
-    "            mdata[\"creation-time\"] = mdata[\"creation-time\"].strftime('%y-%m-%d %H:%M')\n",
+    "    for cname, mdata in module_constants[\"constants\"].items():\n",
     "        print(f'{cname:.<12s}', mdata[\"creation-time\"])\n",
     "\n",
-    "    for cname in [\"Offset\", \"BadPixelsDark\", \"RelativeGain\", \"BadPixelsFF\"]:\n",
-    "        if cname in md_dict[\"constants\"]:\n",
-    "            module_timestamps[cname] = md_dict[\"constants\"][cname][\"creation-time\"]\n",
+    "    for cname in [\"OffsetGotthard2\", \"BadPixelsDarkGotthard2\", \"RelativeGainGotthard2\", \"BadPixelsFFGotthard2\"]:\n",
+    "        if cname in module_constants[\"constants\"]:\n",
+    "            module_timestamps[cname] = module_constants[\"constants\"][cname][\"creation-time\"]\n",
     "        else:\n",
     "            module_timestamps[cname] = \"NA\"\n",
     "\n",
-    "time_summary = retrieved_constants.setdefault(\"time-summary\", {})\n",
-    "time_summary[\"SAll\"] = timestamps\n",
+    "retrieved_constants[\"time-summary\"] = timestamps\n",
     "\n",
     "metadata.save()"
    ]