Skip to content

Latest commit

 

History

History
487 lines (331 loc) · 30.8 KB

README.md

File metadata and controls

487 lines (331 loc) · 30.8 KB

Themoelectric.py — A Python Tool for Design of High ZT Nanoengineered Thermoelectrics

Thermoelectric.py is a computational framework that computes electron transport coefficients with unique features to design the nanoscale morphology of thermoelectrics (TEs) to obtain electron scattering that will enhance performance through electron energy filtering. The code uses the semiclassical Boltzmann transport equation to compute the TE properties of electrical conductivity, Seebeck coefficient, electron contribution to thermal conductivity, etc., under relaxation time approximation. The code has an interface with the VASP ab initio simulation package. What distinguishes Thermoelectric.py from other software such as BoltzTrap is sets of subtools that are implemented assist in modeling electron transport in semiconductors. These include a tool for self-consistent calculation of the Fermi level from a given carrier concentration, and a fast algorithm that uses Fermi’s golden rule to compute the energy dependent electron scattering rate due nanoparticles, pores and grain boundaries. The first of these subtools circumvent the problem that DFT underestimates the band gaps, and the second performs isosurface integrals to enable very dense but numerically efficient Brillouin Zone mesh sampling.

GETTING STARTED

The overall structure of the repository is as below.

├── Examples             # Tutorials, sanity and performance checks
├── Figures              # List of figures generated by Thermoelectric.py
├── ThirdPartyTools      # Thirs party tools used in this project
├── docs                 # The pdf manual of Thermoelectric.py
├── src                  # Python source files of the project 
├── requirements.txt 
└── README.md

The best place to start is the Examples folder, where there are a couple of scripts available to get you started with the code. A quick description of the notebooks is as the following.

├── Examples 
│   ├── Si_Ideal_Filtering    # Example of running simulation to model idal filtering Si
│   ├── Si_Nanocomposite      # More involving example of thermoelectric properties in Si containing SiC nanoparticles
│   ├── README.md            

INSTALLATION

Compatible with python 3.0 and upwards

git clone https://github.com/ariahosseini/thermoelectric.py.git
cd thermoelectric.py/
pip install --upgrade pip
pip install -r Requirements.txt

You need to define the following environment variable in your .bashrc or .bash_profile

export PYTHONPATH=/PATH/TO/thermoelectric.py/src:/PATH/TO/thermoelectric.py/ThirdPartyTools:$PYTHONPATH

CAPACITY

The Enhancement to Thermoelectric Performance That Could Be Obtained by Designing the Electron Scattering to Optimally Harness the Mechanism of Electron Energy Filtering

Thermoelectric.py shows that using electron energy filtering can completely free engineers from the established paradigm that the optimal carrier concentration is constrained and that only semiconductors can make good thermoelectrics. The model demonstrates that if one applies perfect energy filtering then one can obtain greatly enhanced power factor by doping the material to push the Fermi energy even deep into the conduction band. In fact, it is possible to make TE with optimal performance that are metallic!

drawing

drawing

Design the Nanoscale Morphology of a Thermoelectric to Obtain Favorable Electron Scattering

Thermoelectric.py tool computes the quantum mechanically predicted rates of electron scattering from heterogeneities with a variety of different geometries to find design strategies to this problem. I have found that the detrimental effect of pores can be largely mitigated in the thermoelectric design by subtly tuning the doping concentration to higher carrier concentration compared to bulk materials. As a design strategy, for the largest enhancement in Seebeck one needs to get in pores of any shape, if one can make them as small as possible.

drawing

THEORY

Thermoelectrics (TE) are a class of materials that convert heat directly into electricity. The performance of TE materials at a given temperature, 𝑇, is quantified by a dimensionless figure of merit ZT=(σS2)/κ T, where κ, σ and S are the material’s thermal conductivity, electrical conductivity and Seebeck coefficient, respectively. The power factor (σS2) in ZT depends on a combination of strongly interdependent electrical transport properties, that have a countervailing dependence of the charge carrier concentration. The tradeoff of these parameters is well understood, and it has become an accepted truth that optimal TE performance can only be obtained in semiconductors that are highly doped to a narrow window of optimized charge carrier concentration. If made sufficiently efficient and inexpensive, these materials could be used to recapturing low-grade waste heat from industrial process as useful electrical energy. The potential energy savings are vast. Recent studies have suggested that recuperating only 10% of heat lost into electricity can improve fuel energy efficiency by 20% while other studies has reported that more than 68% of U.S. energy consumption escaped as waste heat.

Model Electron Transport Coefficients in Bulk Thermoelectrics

The electrical conductivity and thermopower of a population of independent charge carriers can be derived from the Boltzmann transport equation by integrating the contribution from all carrier states. In an isotropic system where the states can be enumerated by their energy, and using the single relaxation time approximation for the collision operator, these can be written as integrals over the carrier energy, E, so that σ, S, and κe are given by

drawing

drawing

drawing

Here the function χ(E,T)= ν(E)2∂f(Ef,E,T)/∂E D(E), lumps together the materials density of carrier states, D(E), and group velocity, ν(E), with the energy derivative of the Fermi-Dirac occupancy, f(E,c,T), where f is the Fermi level. The functions γ(E,T)=(E-Ef)χ(E,T) and ζ(E,T)=(E-Ef)2 χ(E,T). These equations also express the relationship between the transport properties and Δn, the moments of the distribution of conductivity over carriers with different energy, defined as

drawing

The Seebeck coefficient obtains its largest magnitude by maximizing the asymmetry of product Dτν2 about the Fermi level to move its center of current, Δ1, away from the Fermi level.

Model Fermi Level

carrierConcentration(self, path2extrinsicCarrierConcentration, bandGap, Ao=None, Bo=None, Nc=None, Nv=None, Temp=None)
fermiLevel(self, carrierConcentration, energyRange, DoS, Nc=None, Ao=None, Temp=None)
fermiLevelSelfConsistent(self, carrierConcentration, Temp, energyRange, DoS, fermilevel)
fermiDistribution(self, energyRange, fermiLevel, Temp=None)

The Fermi level depends strongly on the carrier concentration, which varies non-monotonically with temperature as the solubility of the dopant changes. For a given carrier concentration, a self-consistent approach is developed to compute Ef by setting the conduction band edge as the reference frame and computing Ef that gives the same carrier population in DFT computed band and the given carrier population. This circumvents the problem that DFT underestimates the band gap. In this method Joyce and Dixon approximation of Ef for degenerate semiconductors ((Ef-Ec)/kB ≅ln⁡[(n/Nc)+1/(√8)]n/Nc -(3/16-√3/9) (n/Nc)2) is used as the initial guess. The Ef iterates to meet the relation between charge density and density of state, n=∫EcD(E)f(E)dE.

drawing

The experimental measurements are noisy and so for the transport model, the carrier concentration was represented with the continuous smoothing function fit through the experimental data. This panel shows the Bayesian interpolation fitted to the temperature dependence of the experimentally measured carrier concentration.

drawing

In this pane, the Fermi level is plotted for different carrier concentrations using self-consistent method described above.

Model Electron Lifetime

tau_Screened_Coulomb(self, energyRange, m_c, LD, N)
tau_Unscreened_Coulomb(self, energyRange, m_c, N)
tau_Strongly_Screened_Coulomb(self, D, LD, N)
tau_p(self, energyRange, alpha, Dv, DA, T, vs, D, rho)
tau_p(self, energyRange, alpha, Dv, DA, T, vs, D, rho)
matthiessen(self, *args)

Semiconductor TEs are generally doped to beyond their saturation level. In these materials, strongly screened Columbic force induced by ionized impurities is the main source of scattering. The transition rate between initial and final energy states has SR(Ei,Ef)=(2πNi e4 LD4)/((4πϵϵo )2ℏΩ)δ(Ef-Ei). In this case, the electron lifetime is defined as

drawing

For the strongly screened Columbic potential LD is small so that 1/(LD4) is dominant. In doped semiconductors the Debye length has generalized form of

drawing

where Nc=2((mc kBT)/(2πℏ)2)(3/2). While the electron lifetime in equation serves reasonably well for many semiconductors, one should note two shortcomings of the Born approximation failures for slow moving electrons in Coulomb potential and deficiency of simply computing scattering from a single impurity and then multiplying it by number of impurities in capturing interference effects occur as electron wave propagate through random distribution of impurities in deriving this equation. We model the conduction band effective mass variation with temperature using mc(T)=mc*(1+5αkB T). This model assumes linear dependency on temperature and does not count for degeneracy in high carrier population.

drawing

This panel shows the Debye length for two different carrier concentrations. The solid lines show the model prediction using degenerate form while the dash lines are for the cases in which degeneracy is neglected. To evaluate the Half-order Fermi-Dirac integral, fermi.m by N.Mohankumar & A.Natarajan is suggested, see ThirdPartyTools directory. The running script is as simple as

%% Matlab running script to compute half order Fermi integral

 Ef = dlmread("Ef"); % Fermi level from running thermoelectric.py
 for i = 1:size(Ef,2)
 f1(1,i) = fermi(0.5,Ef_inc(1,i)); The (1/2)-order Fermi-Dirac integral
 f2(1,i) = fermi(-0.5,Ef_inc(1,i)); The (-1/2)-order Fermi-Dirac integral
 end
 dlmwrite('f_inc',[f1;f2]); % Generate the output

A alternative way is to use the Fermi-Dirac Integrals python package (FDINT) - compatable with python2, using following command

pip install fdint

The second important scattering mechanism specially at high temperature in nonpolar semiconductors like Si is the acoustic phonon deformation potential. For electron phonon interaction, Ravich defined the lifetime as

drawing

This equation accounts for both absorption and emission of phonons. Note that the electron lifetime is strongly dominated by ion scattering and has weak dependency on phonon scattering. The other scattering terms of electron-electron and electron intervalley scattering has negligible importance in determining the electron lifetime and are excluded in calculations without loss of accuracy.

The rate of electron scattering due to the disordered arrangement in alloys dielectrics model as

drawing

where x is the atomic fraction of alloy, a is the lattice parameter and the term UA is the alloy scattering potential.

drawing

This panel shows the magnitude of electrical conductivity and Seebeck coefficient in phosphorus-doped bulk silicon. The solid blue line shows the model prediction for electrical conductivity, and the red line shows the prediction for the Seebeck coefficient. The experimentally measured σ and S are marked with open circles.

Model Electron Transport Coefficients in Nanostructured Thermoelectrics

tau2D_cylinder(self, energyRange, nk, Uo, m, vfrac, valley, dk_len, ro, n=2000)
tau3D_spherical(self, energyRange, nk, Uo, m, vfrac, valley, dk_len, ro, n=32)

In the nanostructured of interest in this study, there are two additional electron scattering processes that arise as a result of the morphology: electron scattering at grain boundaries, and scattering from pores. The rate of electron momentum relaxation due to elastic scattering from a uniform dispersion of pores can be modeled as

drawing

Here N is the number density of pores, and the term SRkk' is the rate of transition of an electron from an initial state with wave vector k and energy E to a state k' with energy E' due to a single pore. For a time-invariant potential, the transition rate SR is given by Fermi’s golden rule as

drawing

where the matrix element operator M describes the strength which the pore couples the initial and final states and the number of ways the transition can occur. For Bloch waves, M is given by the integral of the overlap of the initial and final state with the pore potential U(r) so that

drawing

For energy conservative (elastic) scattering between eigenstates with the same energy equation scattering can be recast as a surface integral over the isoenergetic k-space contour that satisfies E(k')=E(k)

drawing

where dS is the incremental area of the isoenergetic k-space surface. In most indirect bandgap semiconductors such as Si, the contours of isoenergy states near to conduction band valley have ellipsoidal shape in momentum space that can be approximated as

drawing

The pore potential, U(r), is assumed to be

drawing

where Uo is the electron affinity. For an infinitely long cylindrical pores with radius ro, and aligned with axis parallel to z, this gives the scattering matrix element operator

drawing

or for the spherical pores/ nanoparticles we have

drawing

We remark that for nanoparticels the band alignment should be used instead of electron affinity. A similar use of Fermi's Golden rule can be used to model the rate of electron scattering by grain boundaries. Minnich et al have suggested that grain boundaries provide a scattering potential of magnitude UGB that decays away from the grain boundary over distance zo. From this, they derived the scattering operator matrix element for a small disc of grain boundary with radius ro as

drawing

The electron lifetime in Si0.8Ge0.2 due to different scattering terms are shown in the panel below.

drawing

CASE STUDY SI BASED NANOCOMPOSITE

Silicon Band Structure

electronBandStructure(self, path2eigenval, skipLines)
bandGap(self, Eg_o, Ao, Bo, Temp=None)
electronDoS(self, path2DoS, headerLines, numDoSpoints, unitcell_volume, valleyPoint, energyRange)
analyticalDoS(self, energyRange, alpha)
electronGroupVelocity(self, kp, energy_kp, energyRange)
analyticalGroupVelocity(self, energyRange, nk, m, valley, dk_len, alpha, temperature)

The terms D(E), and ν(E) for Si were derived from the conduction band of Si computed with density functional theory (DFT) using the Vienna Ab initio Simulation Package (VASP) using generalized gradient approximation (GGA) with the Perdew-Burke-Erzerhof exchange correlation functional (PBE). Projector augmented wave (PAW) pseudopotentials is used represent the ion cores. The Kohm-Sham wave functions constructed using a planewave basis set with 700 eV energy cutoff. The Brillouin zone was sampled using 12×12×12 Monkhorst-Pack k-point grid. The forces on the atoms minimized to better than 10-6 eV/Å to relax the Si primitive cell. The electronic band structure used to compute D(E) on a 45×45×45 k-point grid. The group velocity was obtained from the conduction band curvature, ν=1/ℏ|∇κ E| along the〈100〉directions on the Γ to X Brillouin zone path.

drawing

drawing

Model Prediction for Bulk Si

electricalProperties(self, E, DoS, vg, Ef, dfdE, Temp, tau)

This panel shows the variation of highest Seebeck (thermopower) and PF modeled in this study with carrier concentrations for pores with different shapes at 500 K and 1300 K. The bulk properties are shown in solid black lines.

drawing

Ideal Electron Filtering

filteringEffect(self, U0, tau0, tauOff, energyRange, electronBandStructure, temp, electronDoS, electronGroupVelocity, bandGap, carrierConcentration, fermiLevel, fermiDistribution, factor, q, uIncrement=0.05, tauIncrement=1e-15, tempIndex=0)

For ideal or perfect filtering, a high rate of additional scattering would be applied to all the electrons with energy lower than a certain threshold, Uo, so as to reduce their drift velocity to zero. The calculated change in the room temperature PF of n-doped silicon that would be provided by with ideal filtering is plotted in Figure 1 as a function of filtering threshold, U , and carrier concentration. The key result of this calculation is that if one can control the filtering threshold, the best power performance is to be found at high carrier.

drawing

Effect of Nanopores on Lorenz Number

When advocating for increased carrier concentration in TEs, it is important to determine whether this will cause a significant increase to the denominator of ZT. Hence, we finish our examination of the effect of pores on the room-temperature electrical transport coefficients by briefly discussing the electronic thermal conductivity (κe). The κe is related to σ by Wiedemann Franz law as κe = LTσ. Here, L is the Lorenz number that conventionally varies from 2×(kB/e)2 ≈ 1.48 × 10-8(V2/K2) up to π2/3 × (kB/e)2 ≈ 2.44 × 10-8(V2/K2) for the low carrier concentration and degenerate (free electron) limit, respectively. Lorenz number is related to the moments of the charge carriers, Δn, through L = 1/(eT)22 −Δ12). In bulk Si, the Lorenz number varies monotonically from 1.53 × 10-8 (V2/22) at 1019 1/cm3 to 2.39 × 10-8 (V/K2) at 10212 1/cm3. The figure below shows the variation of Lorenz number The objective of adding porosity is to lower the lattice thermal conductivity, and prior studies have shown that the lattice thermal conductivity in nanoporous Si with the geometries modeled here can be as low as ∼30 W/mK at room temperature. At bulk room temperature, Si with the carrier concentration tuned to optimize ZT, the electronic thermal conductivity is ∼0.3 W/mK still 2 orders of magnitude lower than the lattice conductivity.

drawing

REFERENCES

[1] Chen, G. (2005). Nanoscale energy transport and conversion: a parallel treatment of electrons, molecules, phonons, and photons. Oxford university press.

[2] Lundstrom, M. S., & Jeong, C. (2012). Near-Equilibrium Transport: Fundamentals and Applications (Vol. 2). World Scientific Publishing Company.

[3] Taur, Y., & Ning, T. H. (2013). Fundamentals of modern VLSI devices. Cambridge university press.

[4] Lundstrom, M. (2009). Fundamentals of carrier transport. Cambridge university press.

[5] Nag, B. R. (2012). Electron transport in compound semiconductors (Vol. 11). Springer Science & Business Media.

[6] Levinshtein, M. E., Rumyantsev, S. L., & Shur, M. S. (Eds.). (2001). Properties of Advanced Semiconductor Materials: GaN, AIN, InN, BN, SiC, SiGe. John Wiley & Sons.

[7] Dimitrijev, S. (2012). Principles of semiconductor devices (pp. 253-263). New York: Oxford university press.

CITATION

[1] Mitigating the Effect of Nanoscale Porosity on Thermoelectric Power Factor of Si, Hosseini, S. Aria and Romano, Giuseppe and Greaney, P. Alex, ACS Applied Energy Materials,2021, https://doi.org/10.1021/acsaem.0c02640.

@article{doi:10.1021/acsaem.0c02640,
author = {Hosseini, S. Aria and Romano, Giuseppe and Greaney, P. Alex},
title = {Mitigating the Effect of Nanoscale Porosity on Thermoelectric Power Factor of Si},
journal = {ACS Applied Energy Materials},
volume = {4},
number = {2},
pages = {1915-1923},
year = {2021},
doi = {10.1021/acsaem.0c02640},
URL = {https://doi.org/10.1021/acsaem.0c02640},\ eprint = {https://doi.org/10.1021/acsaem.0c02640}
}

[2] Enhanced Thermoelectric Performance of Polycrystalline Si0.8Ge0.2 Alloys through the Addition of Nanoscale Porosity, , Hosseini, S. Aria and Romano, Giuseppe and Greaney. Advanced Electronic Materials, 2021, under review.

@misc{hosseini2021enhanced,
title={Enhanced Thermoelectric Performance of Polycrystalline $\mathrm{Si_{0.8}Ge_{0.2}}$ Alloys through the Addition of Nanoscale Porosity},
author={S. Aria Hosseini and P. Alex Greaney and Giuseppe Romano},
year={2021},
eprint={2103.14223},
archivePrefix={arXiv},
primaryClass={cond-mat.mtrl-sci}
}