TRIQS/triqs_modest 3.3.0
Modular Electronic Structure Toolkit
Loading...
Searching...
No Matches
obe_tb.hpp
Go to the documentation of this file.
1// Copyright (c) 2025--present, The Simons Foundation
2// This file is part of TRIQS/modest and is licensed under the terms of GPLv3 or later.
3// SPDX-License-Identifier: GPL-3.0-or-later
4// See LICENSE in the root of this distribution for details.
5
6#pragma once
7#include <triqs/tight_binding/tb_hamiltonian.hpp>
8#include <stdexcept>
9#include <triqs/mesh/imfreq.hpp>
10#include "loaders.hpp"
11#include "triqs/lattice/bz_integrators.hpp"
12#include "triqs/lattice/gloc.hpp"
14#include <nda/nda.hpp>
15#include <triqs/gfs/functions/density.hpp>
16#include "./root_finder.hpp"
17#include "triqs/tight_binding/superlattice.hpp"
18
19namespace triqs::modest {
20
21 using namespace triqs::tb;
22 using namespace triqs::lattice;
23
30 std::vector<tb_hamiltonian> H;
31 //downfolding_projector P;
32 //C2PY_IGNORE std::optional<ibz_symmetry_ops> ibz_symm_ops = {}; //< IBZ symmetrizer after a k-sum
33 };
34
50 one_body_elements_tb one_body_elements_from_wannier90(std::string const &wannier_file_path, spin_kind_e spin_kind,
51 std::vector<atomic_orbs> atomic_shells);
52
65 one_body_elements_tb one_body_elements_from_wannier90(std::string const &wannier_file_path_up, std::string const &wannier_file_path_dn,
66 spin_kind_e spin_kind, std::vector<atomic_orbs> atomic_shells);
67
// tb factories
69
71 C2PY_IGNORE one_body_elements_tb make_obe_from_tb(std::vector<tb_hamiltonian> const tb_H_sigma, spin_kind_e spin_kind,
72 std::vector<atomic_orbs> atomic_shells);
73
82 nda::array<nda::matrix<dcomplex>, 2> Hloc(std::vector<tb_hamiltonian> const &H_sigma, std::vector<atomic_orbs> const &atomic_shells);
83
91 nda::array<nda::matrix<dcomplex>, 2> impurity_levels(one_body_elements_tb const &obe);
92
100 one_body_elements_tb fold(superlattice const &sl, one_body_elements_tb const &obe);
101
111 one_body_elements_tb rotate(one_body_elements_tb const &obe, nda::matrix<dcomplex> const &U);
112
113 // -----------------------------------------------------------------------
114
118
135 template <typename Mesh>
136 block2_gf<Mesh, matrix_valued> gloc(one_body_elements_tb const &obe, double mu, block2_gf<Mesh, matrix_valued> const &Sigma_dynamic,
137 nda::array<nda::matrix<dcomplex>, 2> const &Sigma_static, triqs::lattice::bz_int_options const &opt) {
138
139 auto &mesh = Sigma_dynamic(0, 0).mesh();
140 auto n_sigma = obe.C_space.n_sigma();
141 auto gloc_result = make_block2_gf(mesh, obe.C_space.Gc_block_shape());
142 // TODO also check safety of orbital space sizes...
143 if (n_sigma != Sigma_static.shape(1)) { throw std::runtime_error("Mismatch between the spin channels in Sigma_Static and Sigma_Dynamic"); }
144 if (n_sigma != obe.H.size()) { throw std::runtime_error("Mismatch between the spin channels in Sigma and spin channels in Hamiltonian."); }
145
146 // Embedding decomposition from structure of Sigma -- provides a list of block names
147 auto embedding_decomp = get_struct(Sigma_dynamic).dims(r_all, 0) | tl::to<std::vector>();
148
149 for (auto sigma : range(n_sigma)) {
150
151 // spin index
152 auto Sigma_full_space = gfs::gf(mesh, {obe.H[sigma].n_orbitals(), obe.H[sigma].n_orbitals()}); //
153 for (auto &&[block, R] : enumerated_sub_slices(embedding_decomp)) {
154 for (auto [n, w] : enumerate(mesh)) {
155 Sigma_full_space.data()(n, R, R) = Sigma_dynamic(block, sigma).data()(n, r_all, r_all) + Sigma_static(block, sigma);
156 }
157 }
158 // Call the TRIQS version of this function
159 gloc_result(0, sigma) = triqs::lattice::gloc(obe.H[sigma], mu, Sigma_full_space, opt);
160 }
161 return gloc_result;
162 }
163
177 template <typename Mesh>
178 block2_gf<Mesh, matrix_valued> gloc(Mesh const &mesh, one_body_elements_tb const &obe, double mu, triqs::lattice::bz_int_options const &opt) {
179 auto result = make_block2_gf(mesh, obe.C_space.Gc_block_shape());
180 for (auto sigma : range(obe.C_space.n_sigma())) { result(0, sigma) = gloc(mesh, obe.H[sigma], mu, opt); }
181 return result;
182 }
183
185
186 // -----------------------------------------------------------------------
187
200 template <typename Mesh>
201 double density(one_body_elements_tb const &obe, double mu, block2_gf<Mesh, matrix_valued> const &Sigma_dynamic,
202 nda::array<nda::matrix<dcomplex>, 2> const &Sigma_static, triqs::lattice::bz_int_options const &opt) {
203
204 //auto n_blocks = Sigma_dynamic.size1();
205 auto n_sigma = obe.C_space.n_sigma();
206
207 double n = 0;
208 auto Gloc = gloc(obe, mu, Sigma_dynamic, Sigma_static, opt); // returns block2gf (1, nsigma, {norb, norb})
209 // return type of Gloc is a B2GF with dimensions (1, nspin, {norb, norb})
210 for (auto sigma : range(n_sigma)) { // spin index
211 n += real(nda::trace(density(Gloc(0, sigma))));
212 }
213 return n;
214 }
215
216 // -----------------------------------------------------------------------
232 template <typename Mesh>
233 double find_chemical_potential(double const target_density, one_body_elements_tb const &obe, block2_gf<Mesh, matrix_valued> const &Sigma_dynamic,
234 nda::array<nda::matrix<dcomplex>, 2> const &Sigma_static, triqs::lattice::bz_int_options const &opt,
235 std::string method = "dichotomy", double precision = 1.e-5, bool verbosity = true) {
236 std::function<double(double)> f = [&obe, &Sigma_dynamic, &Sigma_static, &opt](double x) {
237 return density(obe, x, Sigma_dynamic, Sigma_static, opt);
238 };
239 return std::get<0>(triqs::root_finder(method, f, 0.0, target_density, precision, 0.5, 1000, "Chemical Potential", "Total Density", verbosity));
240 }
241
256 template <typename Mesh>
257 double find_chemical_potential(double const target_density, one_body_elements_tb const &obe, Mesh const &mesh,
258 triqs::lattice::bz_int_options const &opt, std::string method = "dichotomy", double precision = 1.e-5,
259 bool verbosity = true) {
260
261 auto Sigma_dynamic = make_block2_gf(mesh, obe.C_space.Gc_block_shape());
262 auto Sigma_static = nda::array<nda::matrix<dcomplex>, 2>(1, obe.C_space.n_sigma());
263 for (auto [i, j] : Sigma_static.indices()) { Sigma_static(i, j) = nda::zeros<dcomplex>(obe.C_space.dim(), obe.C_space.dim()); }
264 return find_chemical_potential(target_density, obe, Sigma_dynamic, Sigma_static, opt, method, precision, verbosity);
265 }
266
267 // -------- instantiations --------------
268
270 template block2_gf<mesh::imfreq, matrix_valued> gloc(one_body_elements_tb const &obe, double mu,
271 block2_gf<mesh::imfreq, matrix_valued> const &Sigma_dynamic,
272 nda::array<nda::matrix<dcomplex>, 2> const &Sigma_static,
273 triqs::lattice::bz_int_options const &opt);
274
275 template block2_gf<mesh::imfreq, matrix_valued> gloc(mesh::imfreq const &mesh, one_body_elements_tb const &obe, double mu,
276 triqs::lattice::bz_int_options const &opt);
277
278 template double density(one_body_elements_tb const &obe, double mu, block2_gf<mesh::imfreq, matrix_valued> const &Sigma_dynamic,
279 nda::array<nda::matrix<dcomplex>, 2> const &Sigma_static, triqs::lattice::bz_int_options const &opt);
280
281 template double find_chemical_potential(double const target_density, one_body_elements_tb const &obe,
282 block2_gf<mesh::imfreq, matrix_valued> const &Sigma_dynamic,
283 nda::array<nda::matrix<dcomplex>, 2> const &Sigma_static, triqs::lattice::bz_int_options const &opt,
284 std::string method, double precision, bool verbosity);
285
286 template double find_chemical_potential(double const target_density, one_body_elements_tb const &obe, mesh::imfreq const &mesh,
287 triqs::lattice::bz_int_options const &opt, std::string method, double precision, bool verbosity);
288
291} // namespace triqs::modest
Describe the atomic orbitals within downfolded space.
long n_sigma() const
Dimension of the index.
long dim() const
Dimension of the correlated space.
C2PY_IGNORE gf_struct2_t Gc_block_shape() const
Shape of the Green function in the correlated space, without block decomposition.
#define C2PY_IGNORE
Definition defs.hpp:17
block2_gf< Mesh, matrix_valued > gloc(one_body_elements_on_grid const &obe, double mu, block2_gf< Mesh, matrix_valued > const &Sigma_dynamic, nda::array< nda::matrix< dcomplex >, 2 > const &Sigma_static)
Compute local Green's function on a mesh.
nda::array< nda::matrix< dcomplex >, 2 > impurity_levels(one_body_elements_on_grid const &obe)
Compute the local impurity levels from the single-particle dispersion.
double find_chemical_potential(double const target_density, one_body_elements_on_grid const &obe, double beta, std::string method="dichotomy", double precision=1.e-5, bool verbosity=true)
Find the chemical potenital from the local Green's function given a target density.
Definition density.hpp:199
double density(one_body_elements_on_grid const &obe, double mu, block2_gf< Mesh, matrix_valued > const &Sigma_dynamic, nda::array< nda::matrix< dcomplex >, 2 > const &Sigma_static)
Compute the density of the lattice Green's function with a self-energy using Woodbury.
Definition density.hpp:93
one_body_elements_tb one_body_elements_from_wannier90(std::string const &wannier_file_path, spin_kind_e spin_kind, std::vector< atomic_orbs > atomic_shells)
Construct a one-body elements TB object from Wannier90 in the case of a single spin index.
Definition obe_tb.cpp:23
block2_gf< Mesh, matrix_valued > make_block2_gf(Mesh const &mesh, gf_struct2_t const &gf_s)
Definition gf_supp.hpp:41
gf_struct_t get_struct(block_gf< Mesh > const &g)
Definition gf_supp.hpp:51
one_body_elements_tb make_obe_from_tb(std::vector< tb_hamiltonian > H_sigma, spin_kind_e spin_kind, std::vector< atomic_orbs > atomic_shells)
Helper to contruct and return an OBE_tb object given a list of tb_Hamiltonians of length n_sigma.
Definition obe_tb.cpp:121
one_body_elements_tb rotate(one_body_elements_tb const &obe, nda::matrix< dcomplex > const &U)
Rotate a tight-binding Hamiltonian by a unitary matrix .
Definition obe_tb.cpp:157
one_body_elements_tb fold(tb::superlattice const &sl, one_body_elements_tb const &obe)
Definition obe_tb.cpp:140
spin_kind_e
Kind of σ index.
nda::array< nda::matrix< dcomplex >, 2 > Hloc(std::vector< tb_hamiltonian > const &H_sigma, std::vector< atomic_orbs > const &atomic_shells)
Compute given tight binding Hamiltonians.
Definition obe_tb.cpp:61
std::pair< double, double > root_finder(std::string method, std::function< double(double)> f, double x_init, double y_value, double precision, double delta_x, long max_loops=1000, std::string x_name="", std::string y_name="", bool verbosity=false)
Root finder .
static constexpr auto r_all
Definition defs.hpp:40
generator< std::pair< long, nda::range > > enumerated_sub_slices(auto sub_div)
A one-body elements using a tight-binding Hamiltonian.
Definition obe_tb.hpp:28
std::vector< tb_hamiltonian > H
List of TB Hamiltonians.
Definition obe_tb.hpp:30
local_space C_space
Local space.
Definition obe_tb.hpp:29