{
"cells": [
{
"cell_type": "code",
"execution_count": 162,
"id": "896e74b5-b3e2-49b6-b3ae-33208f169a3b",
"metadata": {},
"outputs": [],
"source": [
"%matplotlib inline\n",
"%config InlineBackend.figure_format = 'svg'\n",
"from triqs.plot.mpl_interface import plt, oplot\n",
"\n",
"import numpy as np\n",
"from triqs.gf import *"
]
},
{
"cell_type": "markdown",
"id": "993decd1-bf94-4f5a-afaf-e0d6fd47b19c",
"metadata": {},
"source": [
"# The Two-Particle Self Consistency (TPSC) method\n",
"\n",
"The Two-Particle Self Consistent (TPSC) method is an approach to solving the single-band Hubbard Model first introduced by Vilk and Tremblay (https://arxiv.org/abs/cond-mat/9702188)."
]
},
{
"cell_type": "markdown",
"id": "96b3991e-e971-4be2-9aea-b8fed2baa7a5",
"metadata": {},
"source": [
"## Theory\n",
"\n",
"Among the simplest approximations to self-energy and susceptibilities are the **Hartree-Fock (HF)** and **Random-Phase-Approximation (RPA)**, which, in the single-band Hubbard model are\n",
"$$\n",
"\\Sigma^\\text{HF}_\\sigma(i\\omega_n, \\mathbf{k}) = U \\braket{n_{-\\sigma}}\n",
"$$\n",
"$$\n",
"\\chi^\\text{RPA}_\\text{sp}(i\\omega_n, \\mathbf{k}) = \\frac{\\chi_0(i\\omega_n, \\mathbf{k})}{1 - \\frac{U}{2}\\chi_0(i\\omega_n, \\mathbf{k})}, \\qquad\n",
"\\chi^\\text{RPA}_\\text{ch}(i\\omega_n, \\mathbf{k}) = \\frac{\\chi_0(i\\omega_n, \\mathbf{k})}{1 + \\frac{U}{2}\\chi_0(i\\omega_n, \\mathbf{k})}\n",
"$$\n",
"The HF-self-energy has the immediate disadvantage of being constant and thus absorbed in the chemical potential.\n",
"\n",
"For the susceptibilities, there exist two sum rules\n",
"$$\n",
"\\begin{align}\n",
"\\frac{T}{N}\\sum_{i\\omega_n, \\mathbf{k}}{\\chi_\\text{sp}(i\\omega_n, \\mathbf{k})} &= n - 2\\braket{n_\\uparrow n_\\downarrow} \\\\\n",
"\\frac{T}{N}\\sum_{i\\omega_n, \\mathbf{k}}{\\chi_\\text{ch}(i\\omega_n, \\mathbf{k})} &= n + 2\\braket{n_\\uparrow n_\\downarrow} - n^2\n",
"\\end{align}\n",
"$$\n",
"which are violated by the RPA-approximations. Also, since the denominator of $\\chi_\\text{sp}$ can vanish, RPA predicts a magnetically ordered phase, which, in two dimensions is prohibited by the **Mermin-Wagner theorem**.\n",
"\n",
"To fix this, TPSC introduces *RPA-like* susceptibilities with screened interaction vertices $U_\\text{ch}$ and $U_\\text{sp}$\n",
"$$\n",
"\\chi^\\text{TPSC}_\\text{sp}(i\\omega_n, \\mathbf{k}) = \\frac{\\chi_0(i\\omega_n, \\mathbf{k})}{1 - \\frac{U_\\text{sp}}{2}\\chi_0(i\\omega_n, \\mathbf{k})}, \\qquad\n",
"\\chi^\\text{TPSC}_\\text{ch}(i\\omega_n, \\mathbf{k}) = \\frac{\\chi_0(i\\omega_n, \\mathbf{k})}{1 + \\frac{U_\\text{ch}}{2}\\chi_0(i\\omega_n, \\mathbf{k})}\n",
"$$\n",
"$U_\\text{ch}$ and $U_\\text{sp}$ are chosen such that the sum rules are fulfilled; for this to work, we need to now the **double occupancy** $\\braket{n_\\uparrow n_\\downarrow}$ for which TPSC makes the *Ansatz*\n",
"$$\n",
"U_\\text{sp} \\braket{n_\\uparrow}\\braket{n_\\downarrow} = U \\braket{n_\\uparrow n_\\downarrow}\n",
"$$\n",
"Having obtained the renormalized vertices and susceptibilities, TPSC then approximates the self-energy as\n",
"$$\n",
"\\Sigma^\\text{TPSC}_\\sigma(i\\omega_n, \\mathbf{k}) = U \\braket{n_{-\\sigma}} + \\frac{U}{8}\\frac{T}{N}\\sum_{i\\nu_m, \\mathbf{q}}{\\left[\n",
"3 U_\\text{sp}\\chi_\\text{sp}(i\\nu_m, \\mathbf{q}) + U_\\text{ch}\\chi_\\text{ch}(i\\nu_m, \\mathbf{q})\n",
"\\right] G_{0\\sigma}(i\\nu_m+i\\omega_n, \\mathbf{q}+\\mathbf{k})}\n",
"$$"
]
},
{
"cell_type": "markdown",
"id": "77cdbb70-69ad-4554-96d6-6f22d3b2e152",
"metadata": {},
"source": [
"## Triangular lattice\n",
"\n",
"In the following, we apply the TPSC method to a triangular two-dimensional Hubbard model.\n",
"The triangular lattice in 2 dimensions is spanned by the primitive lattice vectors\n",
"$$\n",
"\\mathbf{a}_1 = a\\hat{x}, \\qquad \\mathbf{a}_2 = \\frac{a}{2} \\hat{x} + \\frac{\\sqrt{3}a}{2}\\hat{y}\n",
"$$\n",
"For simplicity, we set $a = 1$; in TRIQS we can create such a lattice as follows:"
]
},
{
"cell_type": "code",
"execution_count": 163,
"id": "652cdc47-4ba2-4cde-9194-f47e9c0ad9cd",
"metadata": {},
"outputs": [],
"source": [
"from triqs.lattice.tight_binding import TBLattice\n",
"\n",
"t = -1.0\n",
"mu = -2.0\n",
"\n",
"units = [(1, 0, 0), (1/2, np.sqrt(3)/2, 0)]\n",
"\n",
"hoppings = {(+1,+0) : [[t]],\n",
" (-1,+0) : [[t]],\n",
" (+0,+1) : [[t]],\n",
" (+0,-1) : [[t]],\n",
" (+1,-1) : [[t]],\n",
" (-1,+1) : [[t]],\n",
" (+0,+0) : [[mu]]}\n",
"\n",
"H = TBLattice(units=units, hoppings=hoppings)"
]
},
{
"cell_type": "markdown",
"id": "a81a86f2-b460-474a-808d-13b810d0753d",
"metadata": {},
"source": [
"TRIQS also allows us to calculate the dispersion relation and store it in an object e_k
. We can plot this dispersion along high symmetry lines:"
]
},
{
"cell_type": "code",
"execution_count": 229,
"id": "260c95c7-5baf-4c6f-854f-51cb19c96577",
"metadata": {},
"outputs": [
{
"data": {
"image/svg+xml": [
"\n",
"\n",
"\n"
],
"text/plain": [
""
]
},
"metadata": {},
"output_type": "display_data"
}
],
"source": [
"kmesh = H.get_kmesh(n_k=(64, 64, 1))\n",
"\n",
"e_k = H.fourier(kmesh)\n",
"\n",
"# define the high-symmetry points of the triangular lattice\n",
"G = [0.0, 0.0, 0.0]\n",
"M = [1/2, 0.0, 0.0]\n",
"K = [1/3, -1/3, 0.0]\n",
"\n",
"paths = [(G, M), (M, K), (K, G)]\n",
"\n",
"from triqs_tprf.lattice_utils import k_space_path\n",
"k_vecs, k_plot, k_ticks = k_space_path(paths, bz=H.bz, relative_coordinates=False)\n",
"k_vecs_rel, k_plot, k_ticks = k_space_path(paths, bz=H.bz, relative_coordinates=True)\n",
"\n",
"e_k_interp_ref = [ H.tb.fourier(k)[0,0].real for k in k_vecs_rel]\n",
"e_k_interp = np.vectorize(lambda k : e_k(k)[0, 0].real, signature='(n)->()')\n",
"\n",
"plt.plot(k_plot, e_k_interp(k_vecs))\n",
"plt.plot(k_plot, e_k_interp_ref, '--')\n",
"plt.xticks(k_ticks, [r'$\\Gamma$',r'$M$',r'$K$',r'$\\Gamma$'])\n",
"plt.ylabel(r'$\\epsilon(\\mathbf{k})$')\n",
"plt.grid(True)"
]
},
{
"cell_type": "markdown",
"id": "0c2fcd25-d7f8-4b3a-a051-3c5bb3b0d4e6",
"metadata": {},
"source": [
"Since it is a triangular lattice, the dispersion is not particle-hole symmetric. As we can see, this dispersion has a saddle point at the Fermi-level. In 2D, this will lead to a logarithmic divergence in the density of states, called a **van Hove-singularity**.\n",
"The density of states can be calculated with the dos
function:"
]
},
{
"cell_type": "code",
"execution_count": 230,
"id": "52020b50-f35d-4675-9078-96542ca2f15e",
"metadata": {},
"outputs": [
{
"data": {
"text/plain": [
"Text(0, 0.5, '$\\\\rho(\\\\varepsilon)$')"
]
},
"execution_count": 230,
"metadata": {},
"output_type": "execute_result"
},
{
"data": {
"image/svg+xml": [
"\n",
"\n",
"\n"
],
"text/plain": [
""
]
},
"metadata": {},
"output_type": "display_data"
}
],
"source": [
"from triqs.lattice.tight_binding import dos\n",
"\n",
"DOS = dos(tight_binding=H.tb, n_kpts=2**10, n_eps=200, name='dos')[0]\n",
"plt.plot(DOS.eps, DOS.rho)\n",
"plt.xlabel('$\\\\varepsilon$')\n",
"plt.ylabel('$\\\\rho(\\\\varepsilon)$')"
]
},
{
"cell_type": "markdown",
"id": "b898807f-bdf2-4d3d-ad93-666563a793bf",
"metadata": {},
"source": [
"To get a better feeling for the dispersion, we can plot it as a function of $\\mathbf{k}$ within the first Brillouin-Zone. This also allows us to visualize the Fermi-Surface, which in this case is a hexagon (dashed lines):"
]
},
{
"cell_type": "code",
"execution_count": 231,
"id": "8230a0cd-b0c2-4669-a70e-364ddf2c6e1a",
"metadata": {},
"outputs": [
{
"data": {
"image/svg+xml": [
"\n",
"\n",
"\n"
],
"text/plain": [
""
]
},
"metadata": {},
"output_type": "display_data"
}
],
"source": [
"e_k = H.fourier(H.get_kmesh(n_k=512))\n",
"k = np.linspace(-1.0, 1.0, num=200) * 2. * np.pi\n",
"Kx, Ky = np.meshgrid(k, k)\n",
"\n",
"e_k_interp = np.vectorize(lambda kx, ky : e_k([kx, ky, 0])[0, 0].real)\n",
"e_k_interp = e_k_interp(Kx, Ky)\n",
"\n",
"plt.figure()\n",
"\n",
"g_abs = H.bz.units.T @ G\n",
"k_abs = H.bz.units.T @ K\n",
"m_abs = H.bz.units.T @ M\n",
"\n",
"abs_path = [ g_abs, k_abs, m_abs, g_abs ]\n",
"\n",
"K_X = [ p[0] for p in abs_path ]\n",
"K_Y = [ p[1] for p in abs_path ]\n",
"\n",
"plt.plot(K_X, K_Y, '-', color='white')\n",
"\n",
"plt.plot(g_abs[0], g_abs[1], 'co', label='G')\n",
"plt.plot(k_abs[0], k_abs[1], 'ro', label='K')\n",
"plt.plot(m_abs[0], m_abs[1], 'mo', label='M')\n",
"\n",
"extent = (k.min(), k.max(), k.min(), k.max())\n",
"plt.imshow(e_k_interp, cmap=plt.get_cmap('RdBu'),\n",
" extent=extent, origin='lower')\n",
"plt.colorbar()\n",
"plt.contour(Kx, Ky, e_k_interp, levels=[0], linestyles='dashed')\n",
"plt.xlabel(r'$k_x$'); plt.ylabel(r'$k_y$');\n",
"plt.legend(loc='upper left');"
]
},
{
"cell_type": "markdown",
"id": "3aa60ee4-e616-4b36-9faf-87b35a233d17",
"metadata": {},
"source": [
"## Non-interacting susceptibility $\\chi_0$\n",
"\n",
"TRIQS TPRF offers functions to calculate non-interacting Green's functions and susceptibilities from a known dispersion e_k
. Here, we calculate the static susceptibility $\\chi_0(i\\omega_n=0, \\mathbf{k})$:"
]
},
{
"cell_type": "code",
"execution_count": 232,
"id": "7f92806f-2f4d-40d5-9fc4-8fca311f67ca",
"metadata": {},
"outputs": [
{
"name": "stdout",
"output_type": "stream",
"text": [
"\n",
"╔╦╗╦═╗╦╔═╗ ╔═╗ ┌┬┐┌─┐┬─┐┌─┐\n",
" ║ ╠╦╝║║═╬╗╚═╗ │ ├─┘├┬┘├┤ \n",
" ╩ ╩╚═╩╚═╝╚╚═╝ ┴ ┴ ┴└─└ \n",
"Two-Particle Response Function tool-box \n",
"\n",
"beta = 100.0\n",
"nk = 262144\n",
"nw = 32\n",
"norb = 1\n",
"\n",
"Approx. Memory Utilization: 0.38 GB\n",
"\n",
"--> fourier_wk_to_wr\n",
"--> fourier_wr_to_tr\n",
"--> chi0_w0r_from_grt_PH (bubble in tau & r)\n",
"--> chi_wk_from_chi_wr (r->k)\n"
]
}
],
"source": [
"from triqs_tprf.lattice import lattice_dyson_g0_wk\n",
"from triqs_tprf.lattice_utils import imtime_bubble_chi0_wk\n",
"\n",
"beta = 100.\n",
"\n",
"wmesh = MeshDLRImFreq(\n",
" beta=beta, statistic='Fermion',\n",
" eps=1e-6, # Tune to desired accuracy\n",
" w_max=10.0, # Tune to energy range in problem\n",
" )\n",
"\n",
"g0_wk = lattice_dyson_g0_wk(mu=0., e_k=e_k, mesh=wmesh)\n",
"# get the density\n",
"g0_w = Gf(mesh=wmesh, target_shape=())\n",
"g0_w.data[:] = 1/len(e_k.mesh)*np.squeeze(np.sum(g0_wk.data, axis=1))\n",
"target_density = density(g0_w).real\n",
"chi0_wk = imtime_bubble_chi0_wk(g0_wk, nw=1, verbose=True)\n",
"iw0 = chi0_wk.mesh.components[0][0] # get zero Matsubara point to evaluate later"
]
},
{
"cell_type": "markdown",
"id": "0a044cb8-0734-4f18-85bd-9f459871f240",
"metadata": {},
"source": [
"We can now plot the static susceptibility:"
]
},
{
"cell_type": "code",
"execution_count": 233,
"id": "31836ff0-3ad2-434f-a09f-5eade91a2444",
"metadata": {},
"outputs": [
{
"data": {
"image/svg+xml": [
"\n",
"\n",
"\n"
],
"text/plain": [
""
]
},
"metadata": {},
"output_type": "display_data"
}
],
"source": [
"chi0_k_interp = np.vectorize(lambda kx, ky : chi0_wk(Idx(0), [kx, ky, 0])[0, 0].real)\n",
"chi0_k_interp = chi0_k_interp(Kx, Ky)\n",
"\n",
"plt.figure()\n",
"\n",
"extent = (k.min(), k.max(), k.min(), k.max())\n",
"plt.imshow(chi0_k_interp, cmap=plt.get_cmap('RdBu'),\n",
" extent=extent, origin='lower')\n",
"plt.colorbar()\n",
"plt.contour(Kx, Ky, e_k_interp, levels=[0], linestyles='dashed')\n",
"plt.xlabel(r'$k_x$'); plt.ylabel(r'$k_y$');"
]
},
{
"cell_type": "code",
"execution_count": 248,
"id": "09ef0f92-e683-42db-b230-cf06e502f46b",
"metadata": {},
"outputs": [
{
"data": {
"image/svg+xml": [
"\n",
"\n",
"\n"
],
"text/plain": [
""
]
},
"metadata": {},
"output_type": "display_data"
}
],
"source": [
"\n",
"chi0_stat_k = np.array([chi0_wk(Idx(0), k)[0,0,0,0].real for k in k_vecs_rel])\n",
"\n",
"fig, axes = plt.subplots(nrows=1, ncols=1)\n",
"\n",
"axes.plot(k_plot, chi0_stat_k, label='$\\\\chi_0$')\n",
"axes.set_title('Absolute comparison')\n",
"axes.legend(bbox_to_anchor=(1,1))\n",
"axes.set_xticks(k_ticks, [r'$\\Gamma$',r'$M$',r'$K$',r'$\\Gamma$'])\n",
"axes.set_xlabel('$\\\\mathbf{k}$')\n",
"axes.grid(True)\n",
"axes.set_box_aspect(1)"
]
},
{
"cell_type": "markdown",
"id": "c878176c-dcbf-4966-a1c1-2310b9350623",
"metadata": {},
"source": [
"The analytic form of this quantity is known:\n",
"$$\n",
"\\chi_0^\\text{stat}(\\mathbf{k}) = -\\frac{2}{N} \\sum_{\\mathbf{q}}^{\\text{1.BZ}} {\n",
"\\frac{f_\\mu(\\varepsilon(\\mathbf{q})) - f_\\mu(\\varepsilon(\\mathbf{q} + \\mathbf{k}))}\n",
"{\\varepsilon(\\mathbf{q}) - \\varepsilon(\\mathbf{q} + \\mathbf{k})}},\n",
"$$\n",
"where $f_\\mu$ is the Fermi-Dirac-statistic. From this expression, we can see that the peaks of $\\chi_0$ correspond to all possible particle-hole excitations.\n",
"Whenever there exists a wave vector $\\mathbf{k}$ which maps a large portion of the Fermi-surface to another part of the Fermi-surface, then many terms in this sum will contribute to this peak; this phenomenon is known as Fermi-surface nesting and can be observed in the image above. In this case, it is visible at the M-point."
]
},
{
"cell_type": "markdown",
"id": "a76cc0c6-0bd9-42e7-bb12-e1c853fe19fd",
"metadata": {},
"source": [
"## Interacting charge ($\\chi_{ch}$) and spin response ($\\chi_{sp}$)\n",
"\n",
"TRIQS TPRF has a tpsc_solver
-class that can be used to do TPSC-calculations for one-band Hubbard models.\n",
"The solver has to be supplied with the target density, the strength of the Hubbard interaction, an imaginary frequency mesh and a dispersion relation:"
]
},
{
"cell_type": "code",
"execution_count": 214,
"id": "6388a1da-de4e-4e29-a54c-18b666a905fb",
"metadata": {},
"outputs": [
{
"name": "stdout",
"output_type": "stream",
"text": [
"\n",
"╔╦╗╦═╗╦╔═╗ ╔═╗ ┌┬┐┌─┐┌─┐┌─┐\n",
" ║ ╠╦╝║║═╬╗╚═╗ │ ├─┘└─┐│ \n",
" ╩ ╩╚═╩╚═╝╚╚═╝ ┴ ┴ └─┘└─┘\n",
"Two-Particle Self-Consistent method\n",
"\n",
" Using the TPSC-Ansatz for the double occupancy.\n",
"\n",
"len(wmesh) = 21\n",
"nk = 262144\n",
"beta = 10.0\n",
"n = 0.7507420673321673\n",
"U = 2.0\n",
"\n",
"Calculating non-interacting quantities...\n",
"\n",
"Calculating first level of approximation...\n",
"\n",
" Calculating Usp...\n",
"\n",
" Calculating Uch...\n",
"\n",
" Calculating chisp_wk and chich_wk...\n",
"\n",
" Calculating double occupancy...\n",
"\n",
"Summary first level approximation:\n",
" Usp = 1.5896434157730261, Uch = 2.388267598779043\n",
" Double Occupation = 0.11199309130057132\n",
"\n",
" DONE! \n"
]
}
],
"source": [
"from triqs_tprf.tpsc_solver import tpsc_solver\n",
"\n",
"U = 2.0\n",
"S = tpsc_solver(n=target_density, U=U, wmesh=wmesh, e_k=e_k)\n",
"\n",
"S.solve(calc_sigma=False, calc_g=False, check_self_consistency=False)"
]
},
{
"cell_type": "markdown",
"id": "1725d98f-e162-4f19-943a-304f484f1dcb",
"metadata": {},
"source": [
"FIXME need custom function to make chi DLR (target_shape!)"
]
},
{
"cell_type": "code",
"execution_count": 215,
"id": "c87b84f2-9ef3-415e-9525-216894643b55",
"metadata": {},
"outputs": [],
"source": [
"def make_chi_dlr(chi_wk):\n",
" temp = Gf(mesh=chi_wk.mesh, target_shape=(1,1))\n",
" temp.data[:,:,0,0] = chi_wk.data[:,:,0,0,0,0]\n",
" return make_gf_dlr(temp)"
]
},
{
"cell_type": "markdown",
"id": "7a2a0962-39e0-467e-9834-1cef2681a31c",
"metadata": {},
"source": [
"We now plot the non-interacting, and the TPSC-charge- and spin-susceptibilities along high-symmetry paths in the 1. BZ. This allows us to easily compare them:"
]
},
{
"cell_type": "code",
"execution_count": 216,
"id": "738cddf6-f92e-4f68-97be-956e62e3192e",
"metadata": {},
"outputs": [
{
"data": {
"image/svg+xml": [
"\n",
"\n",
"\n"
],
"text/plain": [
""
]
},
"metadata": {},
"output_type": "display_data"
}
],
"source": [
"chi0_stat_k = make_chi_dlr(S.chi0_wk)(iw0, all)\n",
"chi0_stat_k = np.array([chi0_stat_k(k)[0,0].real for k in k_vecs_rel])\n",
"\n",
"chich_stat_k = make_chi_dlr(S.chich_wk)(iw0, all)\n",
"chich_stat_k = np.array([chich_stat_k(k)[0,0].real for k in k_vecs_rel])\n",
"\n",
"chisp_stat_k = make_chi_dlr(S.chisp_wk)(iw0, all)\n",
"chisp_stat_k = np.array([chisp_stat_k(k)[0,0].real for k in k_vecs_rel])\n",
"\n",
"fig, axes = plt.subplots(nrows=1, ncols=2, figsize=(10, 10))\n",
"\n",
"axes[0].plot(k_plot, chi0_stat_k, label='$\\\\chi_0$')\n",
"axes[0].plot(k_plot, chich_stat_k, label='$\\\\chi_{ch}$')\n",
"axes[0].plot(k_plot, chisp_stat_k, label='$\\\\chi_{sp}$')\n",
"axes[0].set_title('Absolute comparison')\n",
"axes[0].legend(bbox_to_anchor=(1,1))\n",
"axes[0].set_xticks(k_ticks, [r'$\\Gamma$',r'$M$',r'$K$',r'$\\Gamma$'])\n",
"axes[0].set_xlabel('$\\\\mathbf{k}$')\n",
"axes[0].grid(True)\n",
"axes[0].set_box_aspect(1)\n",
"\n",
"axes[1].plot(k_plot, chi0_stat_k - chi0_stat_k[0], label='$\\\\chi_0$')\n",
"axes[1].plot(k_plot, chich_stat_k - chich_stat_k[0], label='$\\\\chi_{ch}$')\n",
"axes[1].plot(k_plot, chisp_stat_k - chisp_stat_k[0], label='$\\\\chi_{sp}$')\n",
"axes[1].set_title('Relative comparison')\n",
"axes[1].legend(bbox_to_anchor=(1,1))\n",
"axes[1].set_xticks(k_ticks, [r'$\\Gamma$',r'$M$',r'$K$',r'$\\Gamma$'])\n",
"axes[1].set_xlabel('$\\\\mathbf{k}$')\n",
"axes[1].grid(True)\n",
"axes[1].set_box_aspect(1)\n",
"\n",
"plt.tight_layout()"
]
},
{
"cell_type": "markdown",
"id": "2ab90a1b-ce6f-4611-ba40-97a7a52e13e7",
"metadata": {},
"source": [
"In the left image, we have plotted the absolute values of the susceptibilities; this shows that, when compared to the bare bubble, the spin fluctuations are increased in the interacting system, whereas charge fluctuations are reduced.\n",
"At the same time, the pronounced peak at the M-point due to Fermi-surface nesting is still visible in all three susceptibilities."
]
}
],
"metadata": {
"kernelspec": {
"display_name": "Python 3 (ipykernel)",
"language": "python",
"name": "python3"
},
"language_info": {
"codemirror_mode": {
"name": "ipython",
"version": 3
},
"file_extension": ".py",
"mimetype": "text/x-python",
"name": "python",
"nbconvert_exporter": "python",
"pygments_lexer": "ipython3",
"version": "3.12.3"
}
},
"nbformat": 4,
"nbformat_minor": 5
}