Symbolic and numeric Scientific computing for atomic physics

Size: px
Start display at page:

Download "Symbolic and numeric Scientific computing for atomic physics"

Transcription

1 University of Delaware Computational Science Initiative meeting November 9, 2007 Symbolic and numeric Scientific computing for atomic physics Marianna Safronova

2 outline Motivation Symbolic computing Numeric computing Computational challenges & future projects

3 research field Research field: development of high-precision methodologies for the calculation of the atomic properties and applications of such calculations. This research involves: the study of the fundamental physics problems applications of atomic physics to future technological developments

4 motivation: motivation: fundamental fundamental physics physics Cs experiment, University of Colorado

5 motivation: applications to various fields of physics Search for variation of the fundamental finestructure constant with time Development of the high-precision methodologies, benchmark problems for understanding of atomic properties, tests of ab initio theory and experimental methods, and cross-checks of experiment Determination of nuclear properties such as nuclear magnetic and anapole moments Providing data for astrophysics studies

6 motivation: new technologies Quantum communication, cryptography and Quantum information processing

7 Quantum Computer (Innsbruck) P 1/2 D 5/2 Quantum bit S 1/2

8 motiation: next generation atomic clocks Next - generation ultra precise atomic clock Atoms trapped by laser light The ability to develop more precise optical frequency standards will open ways to improve global positioning system (GPS) measurements and tracking of deep-space probes, perform more accurate measurements of the physical constants and tests of fundamental physics such as searches for gravitational waves, etc.

9 motivation Parity Violation Atomic Clocks P 1/2 D 5/2 NEED ATOMIC PROPERTIES S 1/2 quantum bit Quantum information

10 calculation of atomic properites Step 1 Derivation of the formulas Step 2 Conducting possible analytical calculations to simplify expressions for numeric evaluation Step 3 Writing and debugging the programs for numeric calculations Step 4 Numeric calculations

11 calculation of atomic properites Step 1 Derivation of the formulas Step 2 Conducting possible analytical calculations to simplify expression for numerical evaluation Step 3 Writing and debugging the programs for numerical calculations Steps 1 3: Symbolic computing Step 4 Numeric computation

12 coupled-cluster cluster method The coupled-cluster cluster method sums infinite sets of many-body perturbation theory terms. The wave function of the valence electron v is represented as an expansion that includes all possible single, double, and partial triple excitations. Cs: atom with single (valence) electron outside of a closed core. 1s 2 2s 2 2p 6 3s 2 3p 6 3d 10 4s 2 4p 6 4d 10 5s 2 5p 6 6s core 1s 2 5p 6 6s valence electron

13 coupled-cluster cluster method Ψ v = Lowest order Core (0) Ψ v core valence electron any excited orbital Single-particle excitations + ρ a a Ψ ma (0) ma m a v + ρ a a Ψ m v (0) mv m v v 1 2 mnab... Double-particle excitations + ρ a a a a Ψ + ρ a a a a Ψ + (0) (0) mnab m n b a v mnva m n a v v mna

14 Step 1: 1: derivation of the formulas H (0) v Need for symbolic computing i j l k d b S2 Ψ > : a a a a : aman ar as a aca aaav 0 : c > 800 terms! The code was developed to implement Wick s theorem and simplify the expression.

15 Symbolic program for coupled-cluster cluster method & perturbation theory Input: expression of the type in ASCII format ijkl ρmnwa i j l k m n a w g a a a : a a :: a a a : Output: simplified resulting formula in the LaTex format, ASCII output is also generated.

16 program features 1) The code is set to work with two or three normal products (all possible cases) with large number of operators. 2) The code differentiates between different types of indices, i.e. core (a,b,c, ), valence (v,w,x,y,...), excited orbitals (m,n,r,s, ), and general case (i, j, k, l, ). 3) The operators are ordered as required in the same order for all terms gmnba ρrswc aman ar as aaabac aw 4) The expression is simplified to account for the identical g = terms and symmetry rules,. ijkl g jilk 5) The direct and exchange terms are joined together, % g = g g ijkl ijkl ijlk.

17 Step 2: 2: analytical calculations Certain summations can be carried out analytically Two symbolic programs are currently available: 1) KENTARO currently interfaced with the previous program. 2) RACAH Maple code very convenient to use, but has compatibility problems.

18 Step 3: 3: Symbolic computing for program generation The resulting expressions that need to be evaluated numerically contain very large number of terms, resulting in tedious coding and debugging. The symbolic program generator was developed for this purpose to automatically generate efficient numerical codes for coupled-cluster or perturbation theory terms J j j J j j J j j J k1 k2 k3 jc jd jw jw' c d a b c d ( 1) abcd k1k 2k3 k2 jw' jv ' k3 jw jv k1 jb ja X ( cdab) X ( v ' w' cd) Z ( vwab) k1 k2 k3 ( ε + ε ε ε )( ε + ε ε ε ) c d v' w' a b v' w'

19 Input: Output: Step 3: 3: Symbolic computing for program generation Sample input: list of formulas to be programmed corresponding FORTRAN code for numerical evaluation J j j J j j J j j J k1 k2 k3 jc jd jw jw' c d a b c d ( 1) abcd k1k 2k3 k2 jw' jv ' k3 jw jv k1 jb ja X ( cdab) X ( v ' w' cd) Z ( vwab) k1 k2 k3 ( ε + ε ε ε )( ε + ε ε ε ) c d v' w' a b 1 subroutine term1d(nvp,kvp,nwp,kwp,nv,kv,nw,kw,jtot,res) 2 X[k1](c,d,a,b) X[k2](vp,wp,c,d) Z[k3](v,w,a,b) 3 none 4 4 xx z1=(-1)**(1+jtot+k1+k2+k3+kapc+kapd+kapw+kapwp) xx z2=d6j(2*jtot,jc,jd,2*k2,jwp,jvp) xx z3=d6j(ja,jb,2*jtot,jw,jv,2*k3) xx z4=d6j(jc,jd,2*jtot,jb,ja,2*k1) 5 (e[c,d]-e[vp,wp]) (e[a,b]-e[vp,wp]) 6 No v' w'

20 Step 3: 3: Symbolic computing for program generation Features: Simple input, essentially just type in a formula. Efficient codes are produced Other constructs can be easily added Safety features are build in Works for most formulas Future plans: interface with formula-writing codes

21 Step 4: 4: numerical computation 1. Coupled-cluster method: iterative solution of very large number of equations 2. Relativistic many-body perturbation theory: evaluation of terms such as example considered before 3. Configuration-interaction (CI) method: finding a few eigenvalues of large matrices 4. Combination of coupled-cluster and CI: general super CI code* (in progress)

22 coupled-cluster cluster method

23 coupled-cluster cluster method The excitation coefficients ρ are obtained by the iterative solution of the corresponding equations. Owing to the very large number of the equations the code needs to be very efficient. The inclusion of the triple excitations require new approaches owing to substantially larger memory and computer time requirements. ρ mnab Cs: a,b = 1s 2 2s 2 2p 6 3s 2 3p 6 3d 10 4s 2 4p 6 4d 10 5s 2 5p 6 m,n : finite basis set = (35 13) (35 13) equations ρ mnrvab Extra index r gives at least a factor of (35 13).

24 coupled-cluster cluster method ρ mnab These are really complicated equations!!! Quadruple term: gmnrsρrsab rs a,b core (17 shells) Indices mnrs can be ANY orbitals Basis set: n max =35, l max =6 17x17x(35 35x13) 4 =5 x ! Program has to be exceptionally efficient!

25 computational challenges I. Efficiency of the most complicated terms II. III. IV. Efficient parallelization Numerical methods Keeping up with new hardware/software and corresponding compatibility problems

26 computational challenges 1) Efficiency of the most complicated terms: gmnrsρrsab Can it be improved further? rs Is any time being wasted owing to imperfect loop ordering? Automated code optimization? 2) Efficient parallelization, especially for triple excitations How to do efficient parallelization of iterative procedures with large local files?

27 computational challenges 3) Efficient parallel codes for configuration interaction method (finding few eigenvalues of large matrices) 4) New approaches for the numerical basis sets (currently using B splines) 5) Resolving convergence issues for the iterative procedure in the cases of large excitations from nearby core shells. 6) Computing on multicore machines

28 conclusion Fundamental Physics Atomic Clocks Symbolic and Numeric Computing for Atomic Calculations P 1/2 D 5/2 S 1/2 Quantum bit Quantum information

29 Group web site: other theory collaborations: graduate StudentS: bindiya arora rupsi pal Jenny tchoukova dansha Jiang Charles Clark and Carl Williams (NIST) Walter Johnson (University of Notre Dame) Ulyana Safronova (University of Nevada-Reno) Michael Kozlov (Petersburg Nuclear Physics Institute) Victor Flambaum and Vladimir Dzuba (UNSW, Australia)

30 nsf workshop on cyber-enabled enabled discovery and innovation ( cdi ) NSF solicitation Workshop page

current status And future prospects

current status And future prospects September 20, 2007 Rare Isotopes & Fundamental symmetries workshop Atomic pnc theory: current status And future prospects marianna safronova outline Motivation & Summary of experiment Nuclear spin-independent

More information

CURRENT STATUS AND FUTURE PROSPECTS

CURRENT STATUS AND FUTURE PROSPECTS AMO seminar - Berkeley March 18, 2008 ATOMIC PNC THEORY: CURRENT STATUS AND FUTURE PROSPECTS MARIANNA SAFRONOVA OUTLINE Motivation & Summary of experiment Nuclear spin-independent PNC & weak charge How

More information

ATOMIC CALCULATIONS FOR TESTS OF FUNDAMENTAL PHYSICS

ATOMIC CALCULATIONS FOR TESTS OF FUNDAMENTAL PHYSICS University of Virginia Colloquium ATOMIC CALCULATIONS FOR TESTS OF FUNDAMENTAL PHYSICS MARIANNA SAFRONOVA November 11, 2011 OUTLINE Atomic physics tests of fundamental physics Parity violation Search for

More information

ATOMIC PARITY VIOLATION

ATOMIC PARITY VIOLATION ATOMIC PARITY VIOLATION OUTLINE Overview of the Atomic Parity Violation Theory: How to calculate APV amplitude? Analysis of Cs experiment and implications for search for physics beyond the Standard Model

More information

Atomic Clocks and the Search for Variation of Fundamental Constants

Atomic Clocks and the Search for Variation of Fundamental Constants January 22, 2015 Atomic Clocks and the Search for Variation of Fundamental Constants MARIANNA SAFRONOVA University of Maryland Outline Blackbody radiation shifts in atomic clocks: Al +, Yb, Sr Theoretical

More information

Triple excitations in the coupled-cluster method. Application to atomic properties.

Triple excitations in the coupled-cluster method. Application to atomic properties. Triple excitations in the coupled-cluster method. Application to atomic properties. Sergey G. Porsev 1 and Andrei Derevianko 2 1 Petersburg Nuclear Physics Institute Gatchina, Russia 2 University of Nevada

More information

INTERACTION PLUS ALL-ORDER METHOD FOR ATOMIC CALCULATIONS

INTERACTION PLUS ALL-ORDER METHOD FOR ATOMIC CALCULATIONS DAMOP 2010 May 29, 2010 DEVELOPMENT OF A CONFIGURATION-INTERACTION INTERACTION PLUS ALL-ORDER METHOD FOR ATOMIC CALCULATIONS MARIANNA SAFRONOVA MIKHAIL KOZLOV PNPI, RUSSIA DANSHA JIANG UNIVERSITY OF DELAWARE

More information

BLACKBODY RADIATION SHIFTS AND MAGIC WAVELENGTHS FOR ATOMIC CLOCK RESEARCH

BLACKBODY RADIATION SHIFTS AND MAGIC WAVELENGTHS FOR ATOMIC CLOCK RESEARCH IEEE-IFCS IFCS 2010, Newport Beach, CA June 2, 2010 BLACKBODY RADIATION SHIFTS AND MAGIC WAVELENGTHS FOR ATOMIC CLOCK RESEARCH Marianna Safronova 1, M.G. Kozlov 1,2 Dansha Jiang 1, and U.I. Safronova 3

More information

List of Publications (Peer-Reviewed Journals)

List of Publications (Peer-Reviewed Journals) List of Publications (Peer-Reviewed Journals) 1. Blackbody radiation shift in a 43 Ca+ ion optical frequency standard, Bindiya Arora, M.S. Safronova, and Charles W. Clark, submitted to Phys. Rev. Lett.

More information

Excitation energies, polarizabilities, multipole transition rates, and lifetimes of ions along the francium isoelectronic sequence

Excitation energies, polarizabilities, multipole transition rates, and lifetimes of ions along the francium isoelectronic sequence Excitation energies, polarizabilities, multipole transition rates, and lifetimes of ions along the francium isoelectronic sequence U. I. Safronova* Physics Department, University of Nevada, Reno, Nevada

More information

Determination of electric-dipole matrix elements in K and Rb from Stark shift measurements

Determination of electric-dipole matrix elements in K and Rb from Stark shift measurements Determination of electric-dipole matrix elements in K and Rb from Stark shift measurements Bindiya Arora and M. S. Safronova Department of Physics and Astronomy, University of Delaware, Newark, Delaware

More information

Atomic Calculations for Future Technology and Study of Fundamental Problems

Atomic Calculations for Future Technology and Study of Fundamental Problems Atomic Calculations for Future Technology and Study of Fundamental Problems M. S. Safronova Department of Physics and Astronomy, University of Delaware, Newark, DE 19716, USA Abstract. Selected modern

More information

Atomic-Physics Tests of QED & the Standard Model

Atomic-Physics Tests of QED & the Standard Model Atomic-Physics Tests of QED & the Standard Model W.R. Johnson Notre Dame University http://www.nd.edu/ johnson Abstract A brief review of tests of strong-field QED in many-electron atoms and of atomic

More information

Theoretical study of lifetimes and polarizabilities in Ba +

Theoretical study of lifetimes and polarizabilities in Ba + PHYSICAL REVIEW A 78, 012508 2008 Theoretical study of lifetimes and polarizabilities in Ba + E. Iskrenova-Tchoukova and M. S. Safronova Department of Physics and Astronomy, University of Delaware, Newark,

More information

Theory of Electric Dipole Moments of Atoms and Molecules Bhanu Pratap Das

Theory of Electric Dipole Moments of Atoms and Molecules Bhanu Pratap Das Theory of Electric Dipole Moments of Atoms and Molecules Bhanu Pratap Das Theoretical Physics and Astrophysics Group Indian Institute of Astrophysics Bangalore Collaborators: H. S. Nataraj, B. K. Sahoo,

More information

Precise Relativistic many-body calculations for alkali-metal atoms

Precise Relativistic many-body calculations for alkali-metal atoms Precise Relativistic many-body calculations for alkali-metal atoms W.R. Johnson, M.S. Safronova, and A. Derevianko Notre Dame University http://www.nd.edu/ johnson Abstract The single-double (SD) method,

More information

Parity Nonconservation in Atoms: The Weak Charge and Anapole Moment of 133 Cs

Parity Nonconservation in Atoms: The Weak Charge and Anapole Moment of 133 Cs Parity Nonconservation in Atoms: The Weak Charge and Anapole Moment of 133 Cs Walter Johnson University of Notre Dame 1) Weak charge Q W of 133 Cs provides a test of the Standard Electroweak Model. 2)

More information

Electric quadrupole moments of metastable states of Ca +,Sr +, and Ba +

Electric quadrupole moments of metastable states of Ca +,Sr +, and Ba + Electric quadrupole moments of metastable states of Ca +,Sr +, and Ba + Dansha Jiang and Bindiya Arora Department of Physics and Astronomy, University of Delaware, Newark, Delaware 19716-2570, USA M. S.

More information

HIGH PRECISION CALCULATION FOR THE DEVELOPMENT OF ATOMIC CLOCK AND THE SEARCH BEYOND THE STANDARD MODEL. Z. Zuhrianda

HIGH PRECISION CALCULATION FOR THE DEVELOPMENT OF ATOMIC CLOCK AND THE SEARCH BEYOND THE STANDARD MODEL. Z. Zuhrianda HIGH PRECISION CALCULATION FOR THE DEVELOPMENT OF ATOMIC CLOCK AND THE SEARCH BEYOND THE STANDARD MODEL by Z. Zuhrianda A dissertation submitted to the Faculty of the University of Delaware in partial

More information

arxiv: v1 [physics.atom-ph] 26 Jan 2012

arxiv: v1 [physics.atom-ph] 26 Jan 2012 Electric dipole moment enhancement factor of thallium S. G. Porsev 1,2, M. S. Safronova 1, and M. G. Kozlov 2 1 Department of Physics and Astronomy, University of Delaware, Newark, Delaware 19716, USA

More information

Blackbody radiation shift, multipole polarizabilities, oscillator strengths, lifetimes, hyperfine constants, and excitation energies in Ca +

Blackbody radiation shift, multipole polarizabilities, oscillator strengths, lifetimes, hyperfine constants, and excitation energies in Ca + Blackbody radiation shift, multipole polarizabilities, oscillator strengths, lifetimes, hyperfine constants, and excitation energies in Ca + M. S. Safronova 1 and U. I. Safronova 2,3 1 Department of Physics

More information

Dirac-Hartree-Fock code (DHF). To run the code:./dhf <na.in. Walter Johnson, "Atomic structure theory"

Dirac-Hartree-Fock code (DHF). To run the code:./dhf <na.in. Walter Johnson, Atomic structure theory Page Lecture Dirac-Hartree-Fock code. Second-order perturbation theory and running second-order code. Atomic calculations and the search for the variation of the fine-structure constant. Dirac-Hartree-Fock

More information

arxiv: v1 [physics.atom-ph] 22 Dec 2017

arxiv: v1 [physics.atom-ph] 22 Dec 2017 Atomic properties of actinide ions with particle-hole configurations arxiv:1712.08301v1 [physics.atom-ph] 22 Dec 2017 M. S. Safronova 1,2, U. I. Safronova 3, and M. G. Kozlov 4,5 1 Department of Physics

More information

Parity Nonconservation in Cesium: Is the Standard Model in Trouble?

Parity Nonconservation in Cesium: Is the Standard Model in Trouble? Parity Nonconservation in Cesium: Is the Standard Model in Trouble? Walter Johnson Department of Physics Notre Dame University http://www.nd.edu/ johnson May 10, 2001 Abstract This is a brief review of

More information

Tests of fundamental symmetries with atoms and molecules

Tests of fundamental symmetries with atoms and molecules Tests of fundamental symmetries with atoms and molecules 1 Listening to an atom q Coulomb forces + Quantum Electro-Dynamics => a relatively simple interpretation q Unprecedented control over internal and

More information

Breit interaction in heavy atoms

Breit interaction in heavy atoms LETTER TO THE EDITOR Breit interaction in heavy atoms M G Kozlov, SGPorsev, and I I Tupitsyn Petersburg Nuclear Physics Institute, 188350, Gatchina, Russia E-mail: mgk@mf1309.spb.edu St. Petersburg State

More information

Precision calculations of atoms with few valence electrons

Precision calculations of atoms with few valence electrons Precision calculations of atoms with few valence electrons arxiv:physics/0306061v1 [physics.atom-ph] 7 Jun 2003 M.G.Kozlov Petersburg Nuclear Physics Institute, Gatchina, 188300, Russia E-mail:mgk@MF1309.spb.edu

More information

Determination of the static polarizability of the 8s 2 S 1/2 state of atomic cesium

Determination of the static polarizability of the 8s 2 S 1/2 state of atomic cesium Determination of the static polarizability of the 8s 2 S 1/2 state of atomic cesium Mevan Gunawardena School of Electrical and Computer Engineering, Purdue University, West Lafayette, Indiana 4797, USA

More information

Proposed experiment for the anapole measurement in francium. Luis A. Orozco Joint Quantum Institute University of Maryland

Proposed experiment for the anapole measurement in francium. Luis A. Orozco Joint Quantum Institute University of Maryland Proposed experiment for the anapole measurement in francium Luis A. Orozco Joint Quantum Institute University of Maryland FrPNC collaboration: S. Aubin, J. A. Behr, V. Flambaum, E. Gomez, G. Gwinner, K.

More information

Blackbody Radiation Shifts and Theoretical Contributions to Atomic Clock Research

Blackbody Radiation Shifts and Theoretical Contributions to Atomic Clock Research Blackbody Radiation Shifts and Theoretical Contributions to Atomic Clock Research (Invited Paper) M. S. Safronova, M.G. Kozlov, Dansha Jiang, Bindiya Arora, Charles W. Clark, U. I. Safronova, and W. R.

More information

Resolving all-order method convergence problems for atomic physics applications

Resolving all-order method convergence problems for atomic physics applications PHYSICA REVIEW A 83, 052502 (2011) Resolving all-order method convergence problems for atomic physics applications H. Gharibnejad, 1 E. Eliav, 2 M. S. Safronova, 3 and A. Dereviano 1 1 Department of Physics,

More information

Closed-shell Atomic Electric Dipole Moments. K. V. P. Latha Angom Dilip Kumar Singh B. P. Das Rajat Chaudhuri

Closed-shell Atomic Electric Dipole Moments. K. V. P. Latha Angom Dilip Kumar Singh B. P. Das Rajat Chaudhuri Closed-shell Atomic Electric Dipole Moments K. V. P. Latha Angom Dilip Kumar Singh B. P. Das Rajat Chaudhuri An observation of EDM of a non-degenerate physical system is a direct unambiguous evidence of

More information

Atomic Parity Non-Conservation in Francium: The FrPNC Experiment

Atomic Parity Non-Conservation in Francium: The FrPNC Experiment IL NUOVO CIMENTO Vol.?, N.?? Atomic Parity Non-Conservation in Francium: The FrPNC Experiment at TRIUMF S. Aubin( 1 ), E. Gomez( 2 ), J. A. Behr( 3 ), M. R. Pearson( 3 ), D. Sheng( 4 ), J. Zhang( 4 ),

More information

Tune-out wavelength spectroscopy: A new technique to characterize atomic structure. Cass Sackett UVa

Tune-out wavelength spectroscopy: A new technique to characterize atomic structure. Cass Sackett UVa Tune-out wavelength spectroscopy: A new technique to characterize atomic structure Cass Sackett UVa Outline Atomic parity violation experiments why they are important but stalled Tune-out spectroscopy

More information

CURRICULUM VITAE. Marianna S. Safronova Professor

CURRICULUM VITAE. Marianna S. Safronova Professor 217 Sharp Lab Department of Physics and Astronomy University of Delaware Newark, DE 19716 USA Tel. 1(302) 831-8767 Fax 1(302) 831-1637 CURRICULUM VITAE Marianna S. Safronova Professor e-mail: msafrono@udel.edu

More information

Spins and spin-orbit coupling in semiconductors, metals, and nanostructures

Spins and spin-orbit coupling in semiconductors, metals, and nanostructures B. Halperin Spin lecture 1 Spins and spin-orbit coupling in semiconductors, metals, and nanostructures Behavior of non-equilibrium spin populations. Spin relaxation and spin transport. How does one produce

More information

Theory and numerical implementations

Theory and numerical implementations Theory and numerical implementations COMPUTE 2012 Daniel Karlsson Mathematical Physics, Lund University Solid State Theory: Other groups: Claudio Verdozzi (COMPUTE contact) Carl-Olof Almbladh Ulf von Barth

More information

Oslo node. Highly accurate calculations benchmarking and extrapolations

Oslo node. Highly accurate calculations benchmarking and extrapolations Oslo node Highly accurate calculations benchmarking and extrapolations Torgeir Ruden, with A. Halkier, P. Jørgensen, J. Olsen, W. Klopper, J. Gauss, P. Taylor Explicitly correlated methods Pål Dahle, collaboration

More information

Atomic Parity Violation

Atomic Parity Violation Atomic Parity Violation Junghyun Lee APV proposes new physics beyond the standard model of elementary particles. APV is usually measured through the weak nuclear charge Q w, quantifying the strength of

More information

Chapter 10: Multi- Electron Atoms Optical Excitations

Chapter 10: Multi- Electron Atoms Optical Excitations Chapter 10: Multi- Electron Atoms Optical Excitations To describe the energy levels in multi-electron atoms, we need to include all forces. The strongest forces are the forces we already discussed in Chapter

More information

Energy levels and radiative rates for Ne-like ions from Cu to Ga

Energy levels and radiative rates for Ne-like ions from Cu to Ga Pramana J. Phys. (2017) 89:79 DOI 10.1007/s12043-017-1469-x Indian Academy of Sciences Energy levels and radiative rates for Ne-like ions from Cu to Ga NARENDRA SINGH and SUNNY AGGARWAL Department of Physics,

More information

1 Rayleigh-Schrödinger Perturbation Theory

1 Rayleigh-Schrödinger Perturbation Theory 1 Rayleigh-Schrödinger Perturbation Theory All perturbative techniques depend upon a few simple assumptions. The first of these is that we have a mathematical expression for a physical quantity for which

More information

Many-body calculations of the static atom-wall interaction potential for alkali-metal atoms

Many-body calculations of the static atom-wall interaction potential for alkali-metal atoms PHYSICAL REVIEW A VOLUME 57 NUMBER 4 APRIL 1998 Many-body calculations of the static atom-wall interaction potential for alkali-metal atoms A. Derevianko and W. R. Johnson Department of Physics Notre Dame

More information

Walter R. Johnson Atomic Structure Theory

Walter R. Johnson Atomic Structure Theory Walter R. Johnson Atomic Structure Theory Walter R. Johnson Atomic Structure Theory Lectures on Atomic Physics With 21 Figures and 45 Tables 123 Professor Dr. Walter R. Johnson University of Notre Dame

More information

Quantum Physics III (8.06) Spring 2007 FINAL EXAMINATION Monday May 21, 9:00 am You have 3 hours.

Quantum Physics III (8.06) Spring 2007 FINAL EXAMINATION Monday May 21, 9:00 am You have 3 hours. Quantum Physics III (8.06) Spring 2007 FINAL EXAMINATION Monday May 21, 9:00 am You have 3 hours. There are 10 problems, totalling 180 points. Do all problems. Answer all problems in the white books provided.

More information

0 belonging to the unperturbed Hamiltonian H 0 are known

0 belonging to the unperturbed Hamiltonian H 0 are known Time Independent Perturbation Theory D Perturbation theory is used in two qualitatively different contexts in quantum chemistry. It allows one to estimate (because perturbation theory is usually employed

More information

Density Functional Theory. Martin Lüders Daresbury Laboratory

Density Functional Theory. Martin Lüders Daresbury Laboratory Density Functional Theory Martin Lüders Daresbury Laboratory Ab initio Calculations Hamiltonian: (without external fields, non-relativistic) impossible to solve exactly!! Electrons Nuclei Electron-Nuclei

More information

Quantum Computation 650 Spring 2009 Lectures The World of Quantum Information. Quantum Information: fundamental principles

Quantum Computation 650 Spring 2009 Lectures The World of Quantum Information. Quantum Information: fundamental principles Quantum Computation 650 Spring 2009 Lectures 1-21 The World of Quantum Information Marianna Safronova Department of Physics and Astronomy February 10, 2009 Outline Quantum Information: fundamental principles

More information

Atom-molecule molecule collisions in spin-polarized polarized alkalis: potential energy surfaces and quantum dynamics

Atom-molecule molecule collisions in spin-polarized polarized alkalis: potential energy surfaces and quantum dynamics Atom-molecule molecule collisions in spin-polarized polarized alkalis: potential energy surfaces and quantum dynamics Pavel Soldán, Marko T. Cvitaš and Jeremy M. Hutson University of Durham with Jean-Michel

More information

Frequency-dependent polarizabilities of alkali-metal atoms from ultraviolet through infrared spectral regions

Frequency-dependent polarizabilities of alkali-metal atoms from ultraviolet through infrared spectral regions Frequency-dependent polarizabilities of alkali-metal atoms from ultraviolet through infrared spectral regions M. S. Safronova and Bindiya Arora Department of Physics and Astronomy, University of Delaware,

More information

Beyond the Hartree-Fock Approximation: Configuration Interaction

Beyond the Hartree-Fock Approximation: Configuration Interaction Beyond the Hartree-Fock Approximation: Configuration Interaction The Hartree-Fock (HF) method uses a single determinant (single electronic configuration) description of the electronic wavefunction. For

More information

Quantum Chaos as a Practical Tool in Many-Body Physics ESQGP Shuryak fest

Quantum Chaos as a Practical Tool in Many-Body Physics ESQGP Shuryak fest Quantum Chaos as a Practical Tool in Many-Body Physics ESQGP Shuryak fest Vladimir Zelevinsky NSCL/ Michigan State University Stony Brook October 3, 2008 Budker Institute of Nuclear Physics, Novosibirsk

More information

Students & Postdocs Collaborators

Students & Postdocs Collaborators Advancing first-principle symmetry-guided nuclear modeling for studies of nucleosynthesis and fundamental symmetries in nature Students & Postdocs Collaborators NCSA Blue Waters Symposium for Petascale

More information

Nuclear electric dipole moment in the Gaussian expansion method

Nuclear electric dipole moment in the Gaussian expansion method Nuclear electric dipole moment in the Gaussian expansion method Nodoka Yamanaka (ithes Group, RIKEN) In collaboration with E. Hiyama (RIKEN), T. Yamada (Kanto-Gakuin Univ.), Y. Funaki (RIKEN) 2015/10/12

More information

Atomic magnetometers: new twists to the old story. Michael Romalis Princeton University

Atomic magnetometers: new twists to the old story. Michael Romalis Princeton University Atomic magnetometers: new twists to the old story Michael Romalis Princeton University Outline K magnetometer Elimination of spin-exchange relaxation Experimental setup Magnetometer performance Theoretical

More information

Intro to Nuclear and Particle Physics (5110)

Intro to Nuclear and Particle Physics (5110) Intro to Nuclear and Particle Physics (5110) March 13, 009 Nuclear Shell Model continued 3/13/009 1 Atomic Physics Nuclear Physics V = V r f r L r S r Tot Spin-Orbit Interaction ( ) ( ) Spin of e magnetic

More information

The Separated Janet Periodic Table

The Separated Janet Periodic Table The Separated Janet Periodic Table Charles Janet first proposed his periodic table in 1929. The Janet Periodic Table (JPT) is also known as the Left Step Periodic Table. Each step has two rows. One natural

More information

Lecture 4. Beyound the Dirac equation: QED and nuclear effects

Lecture 4. Beyound the Dirac equation: QED and nuclear effects Lecture 4 Beyound the Dirac equation: QED and nuclear effects Plan of the lecture Reminder from the last lecture: Bound-state solutions of Dirac equation Higher-order corrections to Dirac energies: Radiative

More information

Quantum Chaos as a Practical Tool in Many-Body Physics

Quantum Chaos as a Practical Tool in Many-Body Physics Quantum Chaos as a Practical Tool in Many-Body Physics Vladimir Zelevinsky NSCL/ Michigan State University Supported by NSF Statistical Nuclear Physics SNP2008 Athens, Ohio July 8, 2008 THANKS B. Alex

More information

Electric and magnetic multipoles

Electric and magnetic multipoles Electric and magnetic multipoles Trond Saue Trond Saue (LCPQ, Toulouse) Electric and magnetic multipoles Virginia Tech 2017 1 / 22 Multipole expansions In multipolar gauge the expectation value of the

More information

Manifestations of Low-Mass Dark Bosons

Manifestations of Low-Mass Dark Bosons Manifestations of Low-Mass Dark Bosons Yevgeny Stadnik Humboldt Fellow Johannes Gutenberg University, Mainz, Germany Collaborators (Theory): Victor Flambaum (UNSW) Collaborators (Experiment): CASPEr collaboration

More information

13. Basic Nuclear Properties

13. Basic Nuclear Properties 13. Basic Nuclear Properties Particle and Nuclear Physics Dr. Tina Potter Dr. Tina Potter 13. Basic Nuclear Properties 1 In this section... Motivation for study The strong nuclear force Stable nuclei Binding

More information

Nuclear structure and the anapole moment in francium; experiments and proposals. Luis A. Orozco UMD

Nuclear structure and the anapole moment in francium; experiments and proposals. Luis A. Orozco UMD Nuclear structure and the anapole moment in francium; experiments and proposals. Luis A. Orozco UMD Work done in collaboration with Prof. Gene Sprouse from SUNYSB And Prof. David DeMille from Yale University.

More information

ELECTRONIC STRUCTURE OF ATOMS

ELECTRONIC STRUCTURE OF ATOMS ELECTRONIC STRUCTURE OF ATOMS Electron Spin The electron: spins around its own axis acts as an tiny magnet (any moving electrical charge creates a magnetic field around itself) can spin in either of 2

More information

QUALIFYING EXAMINATION, Part 1. 2:00 PM 5:00 PM, Thursday September 3, 2009

QUALIFYING EXAMINATION, Part 1. 2:00 PM 5:00 PM, Thursday September 3, 2009 QUALIFYING EXAMINATION, Part 1 2:00 PM 5:00 PM, Thursday September 3, 2009 Attempt all parts of all four problems. Please begin your answer to each problem on a separate sheet, write your 3 digit code

More information

Blackbody radiation shift, multipole polarizabilities, oscillator strengths, lifetimes, hyperfine constants, and excitation energies in Hg +

Blackbody radiation shift, multipole polarizabilities, oscillator strengths, lifetimes, hyperfine constants, and excitation energies in Hg + Blackbody radiation shift, multipole polarizabilities, oscillator strengths, lifetimes, hyperfine constants, and excitation energies in Hg + M. Simmons 1, U. I. Safronova 2,3, and M. S. Safronova 1 1 Department

More information

Methods for Treating Electron Correlation CHEM 430

Methods for Treating Electron Correlation CHEM 430 Methods for Treating Electron Correlation CHEM 430 Electron Correlation Energy in the Hartree-Fock approximation, each electron sees the average density of all of the other electrons two electrons cannot

More information

Two exactly Coulomb interacting electrons in a finite quantum wire and an external magnetic field.

Two exactly Coulomb interacting electrons in a finite quantum wire and an external magnetic field. University of Iceland Computational physics Two exactly Coulomb interacting electrons in a finite quantum wire and an external magnetic field. Author: Ólafur Jónasson Supervisor: Viðar Guðmundsson January

More information

The Λ(1405) is an anti-kaon nucleon molecule. Jonathan Hall, Waseem Kamleh, Derek Leinweber, Ben Menadue, Ben Owen, Tony Thomas, Ross Young

The Λ(1405) is an anti-kaon nucleon molecule. Jonathan Hall, Waseem Kamleh, Derek Leinweber, Ben Menadue, Ben Owen, Tony Thomas, Ross Young The Λ(1405) is an anti-kaon nucleon molecule Jonathan Hall, Waseem Kamleh, Derek Leinweber, Ben Menadue, Ben Owen, Tony Thomas, Ross Young The Λ(1405) The Λ(1405) is the lowest-lying odd-parity state of

More information

(8) Atomic Physics (1½l, 1½p)

(8) Atomic Physics (1½l, 1½p) 10390-716(8) Atomic Physics (1½l, 1½p) 2018 Course summary: Multi-electron atoms, exclusion principle, electrostatic interaction and exchange degeneracy, Hartree model, angular momentum coupling: L-S and

More information

Electronic quadrupole and hexadecapole moment of the Ni II ground state

Electronic quadrupole and hexadecapole moment of the Ni II ground state Electronic quadrupole and hexadecapole moment of the Ni II ground state Donald R Beck Physics Department, Michigan Technological University, Houghton, MI 49931-1295 USA Draft submitted to J. Phys. B September

More information

Effective Field Theory for Nuclear Physics! Akshay Vaghani! Mississippi State University!

Effective Field Theory for Nuclear Physics! Akshay Vaghani! Mississippi State University! Effective Field Theory for Nuclear Physics! Akshay Vaghani! Mississippi State University! Overview! Introduction! Basic ideas of EFT! Basic Examples of EFT! Algorithm of EFT! Review NN scattering! NN scattering

More information

Parity and Time Reversal Violations in Atoms: Present Status and Future Prospects. Bhanu Pratap Das

Parity and Time Reversal Violations in Atoms: Present Status and Future Prospects. Bhanu Pratap Das Parity and Time Reversal Violations in Atoms: Present Status and Future Prospects Bhanu Pratap Das Non-Accelerator Particle Physics Group Indian Institute of Astrophysics Bangalore 560 034, India Outline

More information

Parity Violation in Diatomic Molecules

Parity Violation in Diatomic Molecules Parity Violation in Diatomic Molecules Jeff Ammon, E. Altuntas, S.B. Cahn, R. Paolino*, D. DeMille Physics Department, Yale University *Physics Department, US Coast Guard Academy DeMille Group Funding:

More information

Multi-reference Density Functional Theory. COLUMBUS Workshop Argonne National Laboratory 15 August 2005

Multi-reference Density Functional Theory. COLUMBUS Workshop Argonne National Laboratory 15 August 2005 Multi-reference Density Functional Theory COLUMBUS Workshop Argonne National Laboratory 15 August 2005 Capt Eric V. Beck Air Force Institute of Technology Department of Engineering Physics 2950 Hobson

More information

Electronic configurations, Auf-bau principle, Pauli principle, Hunds rule 1. Which of the following statements in relation to the hydrogen atom is correct? 1) 3s and 3p orbitals are of lower energy than

More information

Electron Correlation

Electron Correlation Electron Correlation Levels of QM Theory HΨ=EΨ Born-Oppenheimer approximation Nuclear equation: H n Ψ n =E n Ψ n Electronic equation: H e Ψ e =E e Ψ e Single determinant SCF Semi-empirical methods Correlation

More information

Highly accurate quantum-chemical calculations

Highly accurate quantum-chemical calculations 1 Highly accurate quantum-chemical calculations T. Helgaker Centre for Theoretical and Computational Chemistry, Department of Chemistry, University of Oslo, Norway A. C. Hennum and T. Ruden, University

More information

Nuclear structure from chiral-perturbation-theory two- plus three-nucleon interactions

Nuclear structure from chiral-perturbation-theory two- plus three-nucleon interactions Nuclear structure from chiral-perturbation-theory two- plus three-nucleon interactions Petr Navratil Lawrence Livermore National Laboratory* Collaborators: W. E. Ormand (LLNL), J. P. Vary (ISU), E. Caurier

More information

( R)Ψ el ( r;r) = E el ( R)Ψ el ( r;r)

( R)Ψ el ( r;r) = E el ( R)Ψ el ( r;r) Born Oppenheimer Approximation: Ĥ el ( R)Ψ el ( r;r) = E el ( R)Ψ el ( r;r) For a molecule with N electrons and M nuclei: Ĥ el What is E el (R)? s* potential surface Reaction Barrier Unstable intermediate

More information

14. Structure of Nuclei

14. Structure of Nuclei 14. Structure of Nuclei Particle and Nuclear Physics Dr. Tina Potter Dr. Tina Potter 14. Structure of Nuclei 1 In this section... Magic Numbers The Nuclear Shell Model Excited States Dr. Tina Potter 14.

More information

Electronic Structure Theory for Periodic Systems: The Concepts. Christian Ratsch

Electronic Structure Theory for Periodic Systems: The Concepts. Christian Ratsch Electronic Structure Theory for Periodic Systems: The Concepts Christian Ratsch Institute for Pure and Applied Mathematics and Department of Mathematics, UCLA Motivation There are 10 20 atoms in 1 mm 3

More information

The Λ(1405) is an anti-kaon nucleon molecule. Jonathan Hall, Waseem Kamleh, Derek Leinweber, Ben Menadue, Ben Owen, Tony Thomas, Ross Young

The Λ(1405) is an anti-kaon nucleon molecule. Jonathan Hall, Waseem Kamleh, Derek Leinweber, Ben Menadue, Ben Owen, Tony Thomas, Ross Young The Λ(1405) is an anti-kaon nucleon molecule Jonathan Hall, Waseem Kamleh, Derek Leinweber, Ben Menadue, Ben Owen, Tony Thomas, Ross Young The Λ(1405) The Λ(1405) is the lowest-lying odd-parity state of

More information

AN INTRODUCTION TO QUANTUM CHEMISTRY. Mark S. Gordon Iowa State University

AN INTRODUCTION TO QUANTUM CHEMISTRY. Mark S. Gordon Iowa State University AN INTRODUCTION TO QUANTUM CHEMISTRY Mark S. Gordon Iowa State University 1 OUTLINE Theoretical Background in Quantum Chemistry Overview of GAMESS Program Applications 2 QUANTUM CHEMISTRY In principle,

More information

Neutrino and Dark Matter Detections via Atomic Ionizations at sub-kev Sensitivities

Neutrino and Dark Matter Detections via Atomic Ionizations at sub-kev Sensitivities Neutrino and Dark Matter Detections via Atomic Ionizations at sub-kev Sensitivities Chih-Pan Wu Dept. of Physics, National Taiwan University Collaborators: Jiunn-Wei Chen, Chih-Liang Wu (NTU) Chen-Pang

More information

Computational Biology Course Descriptions 12-14

Computational Biology Course Descriptions 12-14 Computational Biology Course Descriptions 12-14 Course Number and Title INTRODUCTORY COURSES BIO 311C: Introductory Biology I BIO 311D: Introductory Biology II BIO 325: Genetics CH 301: Principles of Chemistry

More information

Challenges for Materials to Support Emerging Research Devices

Challenges for Materials to Support Emerging Research Devices Challenges for Materials to Support Emerging Research Devices C. Michael Garner*, James Hutchby +, George Bourianoff*, and Victor Zhirnov + *Intel Corporation Santa Clara, CA + Semiconductor Research Corporation

More information

DFT calculations of NMR indirect spin spin coupling constants

DFT calculations of NMR indirect spin spin coupling constants DFT calculations of NMR indirect spin spin coupling constants Dalton program system Program capabilities Density functional theory Kohn Sham theory LDA, GGA and hybrid theories Indirect NMR spin spin coupling

More information

Chapter 2 Approximation Methods Can be Used When Exact Solutions to the Schrödinger Equation Can Not be Found.

Chapter 2 Approximation Methods Can be Used When Exact Solutions to the Schrödinger Equation Can Not be Found. Chapter 2 Approximation Methods Can be Used When Exact Solutions to the Schrödinger Equation Can Not be Found. In applying quantum mechanics to 'real' chemical problems, one is usually faced with a Schrödinger

More information

Using the PGOPHER program to link experimental spectra with theory Rotations

Using the PGOPHER program to link experimental spectra with theory Rotations Using the PGOPHER program to link experimental spectra with theory Rotations Colin M. Western chool of Chemistry, University of Bristol, Bristol B8 1T, UK Email : C.M.Western@bristol.ac.uk http://pgopher.chm.bris.ac.uk

More information

Lecture 7. both processes have characteristic associated time Consequence strong interactions conserve more quantum numbers then weak interactions

Lecture 7. both processes have characteristic associated time Consequence strong interactions conserve more quantum numbers then weak interactions Lecture 7 Conserved quantities: energy, momentum, angular momentum Conserved quantum numbers: baryon number, strangeness, Particles can be produced by strong interactions eg. pair of K mesons with opposite

More information

High-precision calculation of the parity-nonconserving amplitude in francium

High-precision calculation of the parity-nonconserving amplitude in francium High-precision calculation of the parity-nonconserving amplitude in francium M. S. Safronova and W. R. Johnson Department of Physics, Notre Dame University, Notre Dame, Indiana 46556 Received 6 December

More information

Quantum Information Processing and Quantum Simulation with Ultracold Alkaline-Earth Atoms in Optical Lattices

Quantum Information Processing and Quantum Simulation with Ultracold Alkaline-Earth Atoms in Optical Lattices Quantum Information Processing and Quantum Simulation with Ultracold Alkaline-Earth Atoms in Optical Lattices Alexey Gorshkov California Institute of Technology Mikhail Lukin, Eugene Demler, Cenke Xu -

More information

Semi-Classical perturbation theory Coulomb only First-order most used

Semi-Classical perturbation theory Coulomb only First-order most used direct reactions Models for breakup Semi-Classical perturbation theory Coulomb only First-order most used TDSE (Time Dependent Schrodinger Equation) Coulomb + Nuclear Semi-classical orbit needed DWBA (Distorted

More information

Sparks CH301. Quantum Mechanics. Waves? Particles? What and where are the electrons!? UNIT 2 Day 3. LM 14, 15 & 16 + HW due Friday, 8:45 am

Sparks CH301. Quantum Mechanics. Waves? Particles? What and where are the electrons!? UNIT 2 Day 3. LM 14, 15 & 16 + HW due Friday, 8:45 am Sparks CH301 Quantum Mechanics Waves? Particles? What and where are the electrons!? UNIT 2 Day 3 LM 14, 15 & 16 + HW due Friday, 8:45 am What are we going to learn today? The Simplest Atom - Hydrogen Relate

More information

Constraints on Neutrino Electromagnetic Properties via Atomic Ionizations with Germanium Detectors at sub-kev Sensitivities

Constraints on Neutrino Electromagnetic Properties via Atomic Ionizations with Germanium Detectors at sub-kev Sensitivities Constraints on Neutrino Electromagnetic Properties via Atomic Ionizations with Germanium Detectors at sub-kev Sensitivities Chih-Pan Wu National Taiwan University Collaborators: Jiunn-Wei Chen, Chih-Liang

More information

Ab initio calculations for potential energy surfaces. D. Talbi GRAAL- Montpellier

Ab initio calculations for potential energy surfaces. D. Talbi GRAAL- Montpellier Ab initio calculations for potential energy surfaces D. Talbi GRAAL- Montpellier A theoretical study of a reaction is a two step process I-Electronic calculations : techniques of quantum chemistry potential

More information

Shape Coexistence and Band Termination in Doubly Magic Nucleus 40 Ca

Shape Coexistence and Band Termination in Doubly Magic Nucleus 40 Ca Commun. Theor. Phys. (Beijing, China) 43 (2005) pp. 509 514 c International Academic Publishers Vol. 43, No. 3, March 15, 2005 Shape Coexistence and Band Termination in Doubly Magic Nucleus 40 Ca DONG

More information

4πε. me 1,2,3,... 1 n. H atom 4. in a.u. atomic units. energy: 1 a.u. = ev distance 1 a.u. = Å

4πε. me 1,2,3,... 1 n. H atom 4. in a.u. atomic units. energy: 1 a.u. = ev distance 1 a.u. = Å H atom 4 E a me =, n=,,3,... 8ε 0 0 π me e e 0 hn ε h = = 0.59Å E = me (4 πε ) 4 e 0 n n in a.u. atomic units E = r = Z n nao Z = e = me = 4πε = 0 energy: a.u. = 7. ev distance a.u. = 0.59 Å General results

More information

Electric properties of molecules

Electric properties of molecules Electric properties of molecules For a molecule in a uniform electric fielde the Hamiltonian has the form: Ĥ(E) = Ĥ + E ˆµ x where we assume that the field is directed along the x axis and ˆµ x is the

More information