Spontaneous polarization of ferroelectric BaTiO3

Size: px
Start display at page:

Download "Spontaneous polarization of ferroelectric BaTiO3"

Transcription

1 Spontaneous polarization of ferroelectric BaTiO3 Tutorial on how to use ATK for polarization calculations Version

2 Spontaneous polarization of ferroelectric BaTiO3: Tutorial on how to use ATK for polarization calculations Version Copyright QuantumWise A/S Atomistix ToolKit Copyright Notice All rights reserved. This publication may be freely redistributed in its full, unmodified form. No part of this publication may be incorporated or used in other publications without prior written permission from the publisher.

3 TABLE OF CONTENTS 1. Introduction... 1 Modern theory of polarization Spontaneous polarization of ferroelectric BaTiO The BaTiO3 crystal structure... 3 Setting up the calculation... 3 Performing the calculation... 5 Analyzing the results Born effective charges... 8 Theory and definition... 8 Calculation script... 8 Running the calculation Bibliography Index iii

4 CHAPTER 1. INTRODUCTION Ferroelectric (FE) materials have a spontaneous electric polarization that can be reversed by the application of an external electric field. FE materials find applications in capacitors, ferroelectric random access memory (RAM), and more recently in ferroelectric tunnel junction (FTJ) displaying giant electroresistance effects [4], [5]. One of the most studied FE materials is barium titanate (BaTiO 3 ), which is the topic for this tutorial. Before continuing with the calculations, let us briefly summarize some central theoretical concepts first. MODERN THEORY OF POLARIZATION The theoretical understanding of FE materials is described by the so-called modern theory of polarization [1]. It is common to divide the polarization of a material into electronic and ionic parts. The latter is calculated using a simple classical electrostatic sum of point charges where and are the valence charge and position vector of atom, is the unit cell volume, and the sum runs over all ions in the unit cell. The electronic contribution to the polarization is obtained as [1] where the sum runs over occupied bands, and where is parallel to the direction of polarization, and is a reciprocal lattice vector in the same direction. The states are the cellperiodic parts of the Bloch functions,. The last integral is known as the Berry phase. The integral over the perpendicular directions can easily be converged with a few number of k-points. The number of k-points in the parallel direction should be larger, however. The total polarization is simply the sum of the electronic and ionic contributions, An important finding in Ref. [1] was that the polarization is a multivalued quantity, and in fact forms a lattice. The reason is that the electronic polarization is determined by the Berry phase, which is only defined modulo. Likewise, the ionic contribution would attain a different value if all ionic positions were displaced by a lattice constant in either direction. 1

5 The polarization is thus a periodic function, and the period is called the polarization quantum, volume., where is the electronic charge, is the lattice vector, and is the unit cell Given the multivalued nature of the polarization, it is perhaps not surprising that only differences in polarization,, between two different structures is a well-defined property. ATK computes and reports the electronic and ionic contributions separately, and also reports the polarization quantum. Important In the current implementation of polarization in ATK, the unit cell must be orthogonal (simple cubic, tetragonal, or orthorhombic). There is no explicit check for this in the code, but the results cannot be expected to be correct if a non-orthogonal cell is used. 2

6 CHAPTER 2. SPONTANEOUS POLARIZATION OF FERROELECTRIC BATIO 3 THE BATIO3 CRYSTAL STRUCTURE Barium titanate (BaTiO 3 ) has a tetragonal crystal structure at room temperature, where the unit cell is slightly elongated in the c-direction. An internal stress further shifts the fractional coordinates in the c-direction away from their high symmetry positions. In this tutorial we use the experimental lattice constants and coordinates as obtained from the Inorganic Crystal Structure Database (ICSD). The structure is given in the ATK format below [2] # Set up lattice lattice = SimpleTetragonal(3.9945*Angstrom, *Angstrom) # Define elements elements = [Barium, Titanium, Oxygen, Oxygen, Oxygen] # Define coordinates fractional_coordinates = [[ 0., 0., 0. ], [ 0.5, 0.5, ], [ 0.5, 0.5, ], [ 0.5, 0., ], [ 0., 0.5, ]] # Set up configuration bulk_configuration = BulkConfiguration( bravais_lattice=lattice, elements=elements, fractional_coordinates=fractional_coordinates ) SETTING UP THE CALCULATION You will in this section set up a DFT calculation using the local density approximation (LDA) for the BaTiO 3 crystal and calculate the polarization. You will use VNL for the calculation, and it is recommended that you go through the VNL tutorial to be familiar with the basic work flow. Start up VNL and create a new project for this tutorial. Use a new, empty directory. Select the text in the BaTiO3.py script above and drag it onto the Script Generator interpret the script and open up with the imported geometry. The tool will 3

7 Tip Alternatively you can save the script to a file in the project directory and drag and drop the file to the Script Generator from the VNL main window. Next do the following steps: Change the Default output file to BaTiO3_lda.nc. double-click New Calculator. double-click Analysis and select Polarization. ADJUSTING THE SCRIPT COMPONENTS Now double-click the New Calculator block in the Script panel to open the calculator widget. Select a 5x5x5 k-point sampling; the other default settings are fine. 4

8 The next step is to adjust the settings for the polarization analysis. Double-click the Polarization block in the Script panel. Increase the number of k-points on the diagonal to 20. This is the number of k-points along the lines of integration and needs to be relatively high. You should always check for convergence by comparing calculations with different numbers of k-points. The other k-points with values of 5 correspond to the number of transverse k-points used for averaging over the Brillouin zone. The polarization values converge relatively fast with respect to the number of transverse k-points and we thus use the default value. You have now finished the script setup. Save the script as BaTiO3_lda.py. PERFORMING THE CALCULATION To start the calculation, left-click the tool and select Job Manager from the pop-up menu. icon located in the lower-right of the script Generator The Job Manager will now pop up; press "Run Queue" to run the script. You should see a log window pop up with the output of the calculation. After a few minutes the calculation has finished and you can inspect the results. 5

9 ANALYZING THE RESULTS To inspect the calculated polarization reported in the log file, scroll down to the end of the log file and you will find a report as shown below Polarization Electronic fractional polarization. Values wrapped to the interval [-0.5,0.5] [ e-15 ] Pe= [ e-16 ] [ e-01 ] Ionic fractional polarization. Values wrapped to the interval [-0.5,0.5] [ e+00 ] Pi= [ e+00 ] [ e-01 ] Total fractional polarization. Pt = Pe + Pi. Values wrapped to the interval [-0.5,0.5] [ e-15 ] Pt= [ e-16 ] [ e-01 ] Total cartesian polarization. [ e-15 ] Pt= [ e-16 ] C/Meter**2 [ e-01 ] Polarization quantum. [ e-01 ] Pq= [ e-01 ] C/Meter**2 [ e+00 ] Tip The results can also be inspected by selecting the polarization object in the file Ba- TiO3_lda.nc on the VNL LabFloor and clicking Show Text Representation... 6

10 NOTES The output contains five calculated quantities: First, the electronic fractional polarization is calculated from the Berry phase obtained from the occupied bands, as described in Modern theory of polarization. The three values correspond to the x, y, and z directions. The second quantity is the purely ionic fractional polarization, where and are the valence charge and fractional coordinate of of atom. The third quantity,, is the total fractional polarization, which is the sum of the electronic and ionic parts. As discussed in the section called Modern theory of polarization, the polarization is a multivalued quantity, and therefore all fractional polarizations are wrapped to the interval [-0.5,0.5], which explains the sign change of the polarization in the z-direction. The sum is outside the range and is thus wrapped by adding a fractional quantization quantum (equal to 1), i.e.. The fourth quantity is the total polarization C/m 2. in Cartesian coordinates, expressed in units of The fifth quantity is the polarization quantum theory of polarization. It is relevant that is small compared to. introduced in the section called Modern According to the modern theory of polarization [1], only the difference in polarization between two configurations is a well-defined property. In order to calculate the spontaneous polarization of tetragonal BaTiO 3, it is thus necessary to also compute the polarization of the centrosymmetric, undistorted structure given below: # Set up lattice lattice = SimpleTetragonal(3.9945*Angstrom, *Angstrom) # Define elements elements = [Barium, Titanium, Oxygen, Oxygen, Oxygen] # Define coordinates fractional_coordinates = [[ 0.0, 0., 0. ], [ 0.5, 0.5, 0.5 ], [ 0.5, 0.5, 1.0 ], [ 0.5, 0., 0.5 ], [ 0.0, 0.5, 0.5 ]] # Set up configuration bulk_configuration = BulkConfiguration( bravais_lattice=lattice, elements=elements, fractional_coordinates=fractional_coordinates ) You may repeat the above steps to calculate the polarization for this structure. The results are that all polarization components are zero. The spontaneous polarization of tetragonal BaTiO 3, thus corresponds to the values reported above for the distorted structure. The calculated value for the total Cartesian polarization in the z-direction C/ m 2 compares very well with the experimental value 0.26 C/m 2 [3]. 7

11 CHAPTER 3. BORN EFFECTIVE CHARGES THEORY AND DEFINITION The concept of Born effective charges, denoted, is defined as the change in polarization divided by the amount an ion (or rather the periodic sublattice of equivalent ions) is displaced: where is the unit cell volume, is the total (Cartesian) polarization in direction, and is the coordinate of ion in direction. The Born effective charge is a tensor. When an ion is displaced in direction it clearly affects the polarization in direction, but it may also lead to a change in polarization in a perpendicular direction. In the calculations below the derivative will be approximated using finite differences, such that e.g. where is the polarization along the -direction when atom has been displaced by the amount in the positive/negative -direction. The Born effective charges are useful for analyzing spontaneous polarization results, and are central to the LO-TO optical phonon splitting in polar crystals. Sometimes the Born effective charge is referred to as the effective charge or dynamical charge. CALCULATION SCRIPT Below is a Python script for calculating the Born effective charges the script and try to understand it. for BaTiO 3. Read through # Read saved configuration configuration0 = nlread('batio3_lda.nc', object_id='gid000')[0] # Get the fractional coordinates of read configuration R0 = configuration0.fractionalcoordinates() # Get the elements elements = configuration0.elements() # Get the lattice lattice = configuration0.bravaislattice() 8

12 # From the lattice extract unit cell volume and length of lattice vector in z-direction volume = lattice.unitcellvolume() vectors = lattice.primitivevectors() c = vectors[2][2] # Get the calculator calculator = configuration0.calculator() # Number of atoms numberofatoms = len(r0) # Fractional displacement in the +/- z direction delta_z = 0.01 # Array for storing the calculated Born Charges borncharges = numpy.zeros(numberofatoms) # Loop over atoms in unit cell for natom in range(numberofatoms): # Loop over displacement in positive/negative z-direction # List with polarization values Pz = [] for s in [1,-1]: # Make a copy of the initial coordinates R = R0.copy() # Displace z-coordinate if atom 'natom' R[nAtom,2] += s*delta_z # Make a new configuration with the displaced atom configuration = BulkConfiguration(bravais_lattice=lattice, elements=elements, fractional_coordinates=r) # Set the calculator using the saved configuration as initial state configuration.setcalculator(calculator,initial_state=configuration0) # Update the configuration (DFT calculation) configuration.update() # Calculate polarization. Only use fine k-sampling in the z-direction polarization = Polarization(configuration=configuration, kpoints_a=monkhorstpackgrid(2,2,2), kpoints_b=monkhorstpackgrid(2,2,2), kpoints_c=monkhorstpackgrid(5,5,20), ) # Print polarization nlprint(polarization) # Get the total cartesian polarization Pt = polarization.totalcartesianpolarization() # Append the z-component to the Pz list Pz.append(Pt[2]) # Make a finite difference approximation for the derivative dp = (Pz[0]-Pz[1])/(2*delta_z*c) # Calculate Born charge born_charge = volume*dp # Add the value (in units of electron charge) to the list 'borncharges' borncharges[natom] = born_charge.inunitsof(elementary_charge) 9

13 # Finally print out the results print '' print ' ' print ' Born effective charges (e) ' print ' ' for natom in range(numberofatoms): print ' %2s' %elements[natom].symbol() + ' : %4.4f ' %borncharges[natom] print ' ' print ' Sum : %4.4f ' %numpy.sum(borncharges) print ' ' The script starts with reading the results from the previous calculation. This will serve as a good starting guess for the DFT calculations to be performed later in the script (where the atoms are displaced). Extract the fractional coordinates, the list of elements, the lattice, and the calculator from the configuration, and define a few convenient variables such as the unit cell volume and the length of the C lattice vector. The parameter delta_z is the fractional displacement when calculating the derivatives. There are two for loops in the script. The outer one loops over the atoms in the unit cell, and the inner one (over the variable s) performs the displacements in the positive and negative z- direction. Notice that when the calculator is attached to the configuration configuration.setcalculator(calculator,initial_state=configuration0) we use the calculation from the previous chapter as an initial guess. This speeds up the calculations (also see the tutorial Initializing a calculation from another one.) In the end, the results are printed out. RUNNING THE CALCULATION Download the BaTiO3_born_charge.py script above and save it in the tutorial project folder. To start the calculation, drag the script to the Job Manager and run it. You should see the log window pop up with the output of the calculation. The calculation will approximately take 10 times longer than the single polarization calculation in the previous chapter. When the job is finished, the calculated Born effective charges are written in the log file Born effective charges (e) Ba : Ti : O : O : O :

14 Sum : NOTES The obtained valued compare well with previous calculations [6] as well as experimental values [7]. As indicated by the calculated sum of the Born effective charges, the calculated values fulfill the acoustic sum rule with only a small error. You can easily use the same script to calculate the Born effective charges for other structures, by simply changing the filename on the first line. 11

15 BIBLIOGRAPHY [1] R. D. King-Smith, and D. Vanderbilt, Phys. Rev. B, 47, 1651, 1993 [2] H. D. Megaw, Acta Crystallographica, 15, 972, 1962 [3] H. H. Wieder, Phys. Rev., 99, 1161, 1955 [4] A. Chanthbouala, A. Crassous, V. Garcia, K. Bouzehouane, S. Fusil, X. Moya, J. Allibe, B. Dlubak, J. Grollier, S. Xavier, C. Deranlot, A. Moshar, R. Proksch, N. D. Mathur, M. Bibes,and A. Barthélémy, Nature Nanotechnology, 7, 101, 2012 [5] X. Lou, Y. Zheng, and B. Wang, J. Appl. Phys., 111, , 2012 [6] P. Ghosez, J. P. Michenaud, and X. Gonze, Phys. Rev. B, 58, 6224, 1998 [7] J. D. Axe, Phys. Rev., 157, 429,

16 INDEX 13

Table of Contents. Table of Contents Computing the piezoelectric tensor for AlN. Introduction. Computing the piezoelectric tensor

Table of Contents. Table of Contents Computing the piezoelectric tensor for AlN. Introduction. Computing the piezoelectric tensor Table of Contents Table of Contents Computing the piezoelectric tensor for AlN Introduction The piezoelectric tensor Computing the piezoelectric tensor Analysis of the e 33 e33 coefficient Alternative

More information

Phonons: Bandstructure, thermal transport, thermo-electrics

Phonons: Bandstructure, thermal transport, thermo-electrics Phonons: Bandstructure, thermal transport, thermo-electrics Tutorial Version 2014.0 Phonons: Bandstructure, thermal transport, thermo-electrics: Tutorial Version 2014.0 Copyright 2008 2014 QuantumWise

More information

Spin transport in Magnetic Tunnel Junctions

Spin transport in Magnetic Tunnel Junctions Spin transport in Magnetic Tunnel Junctions Tutorial on spin transport in Fe-MgO-Fe Version 2015.2 Spin transport in Magnetic Tunnel Junctions: Tutorial on spin transport in Fe-MgO-Fe Version 2015.2 Copyright

More information

Table of Contents. Table of Contents Electronic structure of NiO with DFT+U. Introduction The electronic structure of NiO calculated with DFT

Table of Contents. Table of Contents Electronic structure of NiO with DFT+U. Introduction The electronic structure of NiO calculated with DFT Table of Contents Table of Contents Electronic structure of NiO with DFT+U Introduction The electronic structure of NiO calculated with DFT Setting up the calculation Performing the calculation Analysing

More information

Table of Contents. Table of Contents Exploring graphene. Build a graphene sheet Build a CNT Transmission spectrum of a GNR Twisted nanoribbon

Table of Contents. Table of Contents Exploring graphene. Build a graphene sheet Build a CNT Transmission spectrum of a GNR Twisted nanoribbon Table of Contents Table of Contents Exploring graphene Build a graphene sheet Build a CNT Transmission spectrum of a GNR Twisted nanoribbon Transmission spectrum Möbius nanoribbon Buckling a graphene sheet

More information

The DFTB model in ATK-SE

The DFTB model in ATK-SE The DFTB model in ATK-SE Tutorial Version 2014.0 The DFTB model in ATK-SE: Tutorial Version 2014.0 Copyright 2008 2014 QuantumWise A/S Atomistix ToolKit Copyright Notice All rights reserved. This publication

More information

QuantumWise. QuantumWise is now part of Synopsys

QuantumWise. QuantumWise is now part of Synopsys Table of Contents Table of Contents NiSi2 Si interface Create the NiSi2/Si device The screening region Increase the length of the central region Set-up the calculation for the undoped device Dope the device

More information

Table of Contents. Table of Contents Phonon-limited mobility in graphene using the Boltzmann transport equation

Table of Contents. Table of Contents Phonon-limited mobility in graphene using the Boltzmann transport equation Table of Contents Table of Contents Phonon-limited mobility in graphene using the Boltzmann transport equation Geometry and electronic structure of graphene Phonons in Graphene Mobility of graphene 1.

More information

Mustafa Uludogan 1, Tahir Cagin, William A. Goddard, III Materials and Process Simulation Center, Caltech, Pasadena, CA 91125, U.S.A.

Mustafa Uludogan 1, Tahir Cagin, William A. Goddard, III Materials and Process Simulation Center, Caltech, Pasadena, CA 91125, U.S.A. Ab Initio Studies On Phase Behavior of Barium Titanate Mustafa Uludogan 1, Tahir Cagin, William A. Goddard, III Materials and Process Simulation Center, Caltech, Pasadena, CA 91125, U.S.A. 1 Physics Department,

More information

Table of Contents. Table of Contents DFT-1/2 and DFT-PPS density functional methods for electronic structure calculations

Table of Contents. Table of Contents DFT-1/2 and DFT-PPS density functional methods for electronic structure calculations Table of Contents Table of Contents DFT-1/2 and DFT-PPS density functional methods for electronic structure calculations DFT-1/2 methods InP bandstructure using PBE-1/2 III-V type semiconductor band gaps

More information

Table of Contents. Table of Contents Opening a band gap in silicene and bilayer graphene with an electric field

Table of Contents. Table of Contents Opening a band gap in silicene and bilayer graphene with an electric field Table of Contents Table of Contents Opening a band gap in silicene and bilayer graphene with an electric field Bilayer graphene Building a bilayer graphene structure Calculation and analysis Silicene Optimizing

More information

Table of Contents. Table of Contents Spin-orbit splitting of semiconductor band structures

Table of Contents. Table of Contents Spin-orbit splitting of semiconductor band structures Table of Contents Table of Contents Spin-orbit splitting of semiconductor band structures Relavistic effects in Kohn-Sham DFT Silicon band splitting with ATK-DFT LSDA initial guess for the ground state

More information

Table of Contents. Table of Contents Converting lattices: Rhombohedral to hexagonal and back

Table of Contents. Table of Contents Converting lattices: Rhombohedral to hexagonal and back Table of Contents Table of Contents Converting lattices: Rhombohedral to hexagonal and back Conversion between hp and hr representations Converting hp supercell to hr primitive cell Crystal classifications

More information

Table of Contents. Table of Contents Initialize from a converged state. Introduction Examples

Table of Contents. Table of Contents Initialize from a converged state. Introduction Examples Table of Contents Table of Contents Initialize from a converged state Introduction Examples Water molecule example Looping over parameters Stepping up in bias Special example: anti-parallel spin in MTJs

More information

Table of Contents. Table of Contents LAMMPS trajectories into QuantumATK

Table of Contents. Table of Contents LAMMPS trajectories into QuantumATK Table of Contents Table of Contents LAMMPS trajectories into QuantumATK Preparing a LAMMPS script Running LAMMPS Importing to QuantumATK Postprocessing LAMMPS trajectories References 1 2 2 3 3 5 8 QuantumATK

More information

How to compute the Born effective charge tensor. Javier Junquera

How to compute the Born effective charge tensor. Javier Junquera How to compute the Born effective charge tensor Javier Junquera Definition of the Born effective charges, also known as dynamical charges For periodic solids, the Born effective charge of atom is a tensor

More information

Table of Contents. Table of Contents Bi2Se3 topological insulator. Build the Bi2Se3 crystal. Bi2Se3 bulk band structure

Table of Contents. Table of Contents Bi2Se3 topological insulator. Build the Bi2Se3 crystal. Bi2Se3 bulk band structure Table of Contents Table of Contents Bi2Se3 topological insulator Build the Bi2Se3 crystal Lattice Basis Bi2Se3 bulk band structure GGA calculation SOGGA calculation Results Bi2Se3 surface: Spin-orbit band

More information

Table of Contents. Table of Contents Spin Transfer Torque. Introduction. Getting Started

Table of Contents. Table of Contents Spin Transfer Torque. Introduction. Getting Started Table of Contents Table of Contents Spin Transfer Torque Introduction Application in Random Access Memory (RAM Theory Getting Started Collinear Initial State Noncollinear State: 90 Spin Rotation Visualizations

More information

Preparation for the workshop. Part 1. Introduction to the Java applet

Preparation for the workshop. Part 1. Introduction to the Java applet ISODISPLACE Workshop Harold T. Stokes International School in the Use and Applications of the Bilbao Crystallographic Server June 2009, Lekeitio, Spain isodisplace is a tool for exploring the structural

More information

Roger Johnson Structure and Dynamics: Displacive phase transition Lecture 9

Roger Johnson Structure and Dynamics: Displacive phase transition Lecture 9 9.1. Summary In this Lecture we will consider structural phase transitions characterised by atomic displacements, which result in a low temperature structure that is distorted compared to a higher temperature,

More information

MSE 201A Thermodynamics and Phase Transformations Fall, 2008 Problem Set No. 7

MSE 201A Thermodynamics and Phase Transformations Fall, 2008 Problem Set No. 7 MSE 21A Thermodynamics and Phase Transformations Fall, 28 Problem Set No. 7 Problem 1: (a) Show that if the point group of a material contains 2 perpendicular 2-fold axes then a second-order tensor property

More information

Exercises for Windows

Exercises for Windows Exercises for Windows CAChe User Interface for Windows Select tool Application window Document window (workspace) Style bar Tool palette Select entire molecule Select Similar Group Select Atom tool Rotate

More information

Chem 253. Tutorial for Materials Studio

Chem 253. Tutorial for Materials Studio Chem 253 Tutorial for Materials Studio This tutorial is designed to introduce Materials Studio 7.0, which is a program used for modeling and simulating materials for predicting and rationalizing structure

More information

Table of Contents. Table of Contents Using the Crystal Builder. Introduction Crystal structure of black phosphorus Phosphorene and its bandstructure

Table of Contents. Table of Contents Using the Crystal Builder. Introduction Crystal structure of black phosphorus Phosphorene and its bandstructure Table of Contents Table of Contents Using the Crystal Builder Introduction Crystal structure of black phosphorus Phosphorene and its bandstructure Bandstructure References 1 2 2 3 7 9 10 QuantumATK Try

More information

Introduction to solid state physics

Introduction to solid state physics PHYS 342/555 Introduction to solid state physics Instructor: Dr. Pengcheng Dai Professor of Physics The University of Tennessee (Room 407A, Nielsen, 974-1509) Chapter 13: Dielectrics and ferroelectrics

More information

Lecture 05 Structure of Ceramics 2 Ref: Barsoum, Fundamentals of Ceramics, Ch03, McGraw-Hill, 2000.

Lecture 05 Structure of Ceramics 2 Ref: Barsoum, Fundamentals of Ceramics, Ch03, McGraw-Hill, 2000. MME 467 Ceramics for Advanced Applications Lecture 05 Structure of Ceramics 2 Ref: Barsoum, Fundamentals of Ceramics, Ch03, McGraw-Hill, 2000. Prof. A. K. M. Bazlur Rashid Department of MME, BUET, Dhaka

More information

TEMScripts Real-time Crystallography Manual. TEMScripts LLC. Last updated: 11/4/2016

TEMScripts Real-time Crystallography Manual. TEMScripts LLC. Last updated: 11/4/2016 TEMScripts Real-time Crystallography Manual TEMScripts LLC. Last updated: 11/4/2016 Close Digital Micrograph Installation Copy following files to \\Gatan\DigitalMicrograph\PlugIns (normally under C:\Program

More information

properties Michele Catti Dipartimento di Scienza dei Materiali Università di Milano Bicocca, Italy

properties Michele Catti Dipartimento di Scienza dei Materiali Università di Milano Bicocca, Italy Elastic and piezoelectric tensorial properties Michele Catti Dipartimento di Scienza dei Materiali Università di Milano Bicocca, Italy (catti@mater.unimib.it) 1 Tensorial physical properties of crystals

More information

Speed-up of ATK compared to

Speed-up of ATK compared to What s new @ Speed-up of ATK 2008.10 compared to 2008.02 System Speed-up Memory reduction Azafulleroid (molecule, 97 atoms) 1.1 15% 6x6x6 MgO (bulk, 432 atoms, Gamma point) 3.5 38% 6x6x6 MgO (k-point sampling

More information

Phonon calculations with SCAN

Phonon calculations with SCAN Workshop on the SCAN density functional: Fundamentals, practices, and extensions Temple university, Philadelphia May 18th, 2017 Hands-on tutorial 3 Phonon calculations with SCAN Yubo Zhang and Jianwei

More information

Introduction to Hartree-Fock calculations in Spartan

Introduction to Hartree-Fock calculations in Spartan EE5 in 2008 Hannes Jónsson Introduction to Hartree-Fock calculations in Spartan In this exercise, you will get to use state of the art software for carrying out calculations of wavefunctions for molecues,

More information

First-principles calculations of piezoelectricity and polarization rotation in Pb Zr 0.5 Ti 0.5 O 3

First-principles calculations of piezoelectricity and polarization rotation in Pb Zr 0.5 Ti 0.5 O 3 First-principles calculations of piezoelectricity and polarization rotation in Pb Zr 0.5 Ti 0.5 O 3 Zhigang Wu and Henry Krakauer Department of Physics, College of William and Mary, Williamsburg, Virginia

More information

Winmostar tutorial Quantum ESPRESSO Spin Polarization V X-Ability Co,. Ltd. 2017/8/8

Winmostar tutorial Quantum ESPRESSO Spin Polarization V X-Ability Co,. Ltd. 2017/8/8 Winmostar tutorial Quantum ESPRESSO Spin Polarization V7.025 X-Ability Co,. Ltd. question@winmostar.com 2017/8/8 Contents I. SCF calculation II. Bands calculation III. Fermi surface 2 Environment setting

More information

J. Phys. Chem. Solids 61, 147 (2000). Berry-phase theory of proper piezoelectric response David Vanderbilt Department of Physics and Astronomy, Rutgers University, Piscataway, New Jersey 08855-0849 (July

More information

Systematic treatment of displacements, strains, and electric fields in density-functional perturbation theory

Systematic treatment of displacements, strains, and electric fields in density-functional perturbation theory Systematic treatment of displacements, strains, and electric fields in density-functional perturbation theory Xifan Wu, 1 David Vanderbilt, 1 and D. R. Hamann 2 1 Department of Physics and Astronomy, Rutgers

More information

Monte Carlo Simulation of Ferroelectric Domain Structure: Electrostatic and Elastic Strain Energy Contributions

Monte Carlo Simulation of Ferroelectric Domain Structure: Electrostatic and Elastic Strain Energy Contributions Monte Carlo Simulation of Ferroelectric Domain Structure: Electrostatic and Elastic Strain Energy Contributions B.G. Potter, Jr., B.A. Tuttle, and V. Tikare Sandia National Laboratories Albuquerque, NM

More information

Supplementary Figures

Supplementary Figures Supplementary Figures 8 6 Energy (ev 4 2 2 4 Γ M K Γ Supplementary Figure : Energy bands of antimonene along a high-symmetry path in the Brillouin zone, including spin-orbit coupling effects. Empty circles

More information

Electric displacement as the fundamental variable in electronic-structure calculations

Electric displacement as the fundamental variable in electronic-structure calculations Electric displacement as the fundamental variable in electronic-structure calculations CECAM - Centre Européen de Calcul Atomique et Moléculaire EPF Lausanne, Switzerland Conference UC Davis, 6/23/2009

More information

Standards-Based Quantification in DTSA-II Part II

Standards-Based Quantification in DTSA-II Part II Standards-Based Quantification in DTSA-II Part II Nicholas W.M. Ritchie National Institute of Standards and Technology, Gaithersburg, MD 20899-8371 nicholas.ritchie@nist.gov Introduction This article is

More information

Lab 3: Handout Quantum-ESPRESSO: a first principles code, part 2.

Lab 3: Handout Quantum-ESPRESSO: a first principles code, part 2. 1 Lab 3: Handout Quantum-ESPRESSO: a first principles code, part 2. In this lab, we will be using Quantum-ESPRESSO as our first-principles code again. In problem 1, we will compare energy between allotropes

More information

The Abinit project. Coding is based on modern software engineering principles

The Abinit project. Coding is based on modern software engineering principles The Abinit project Abinit is a robust, full-featured electronic-structure code based on density functional theory, plane waves, and pseudopotentials. Abinit is copyrighted and distributed under the GNU

More information

Learning ArcGIS: Introduction to ArcCatalog 10.1

Learning ArcGIS: Introduction to ArcCatalog 10.1 Learning ArcGIS: Introduction to ArcCatalog 10.1 Estimated Time: 1 Hour Information systems help us to manage what we know by making it easier to organize, access, manipulate, and apply knowledge to the

More information

Lab 1: Empirical Energy Methods Due: 2/14/18

Lab 1: Empirical Energy Methods Due: 2/14/18 Lab 1: Empirical Energy Methods Due: 2/14/18 General remarks on scientific scripting Scientific scripting for managing the input and output data is an important component of modern materials computations,

More information

Spin transport in Magnetic Tunnel Junctions

Spin transport in Magnetic Tunnel Junctions Spin transport in Magnetic Tunnel Junctions This tutorial shows how to simulate and analyze the electronic transport properties of magnetic tunnel junctions (MTJs). You will study the collinear and non-collinear

More information

Lab 1 Uniform Motion - Graphing and Analyzing Motion

Lab 1 Uniform Motion - Graphing and Analyzing Motion Lab 1 Uniform Motion - Graphing and Analyzing Motion Objectives: < To observe the distance-time relation for motion at constant velocity. < To make a straight line fit to the distance-time data. < To interpret

More information

Road map (Where are we headed?)

Road map (Where are we headed?) Road map (Where are we headed?) oal: Fairly high level understanding of carrier transport and optical transitions in semiconductors Necessary Ingredients Crystal Structure Lattice Vibrations Free Electron

More information

arxiv:cond-mat/ v1 10 Jun 1994 K. M. Rabe

arxiv:cond-mat/ v1 10 Jun 1994 K. M. Rabe October 2, 2018 Phase transitions in BaTiO 3 from first principles W. Zhong and David Vanderbilt Department of Physics and Astronomy, Rutgers University, Piscataway, NJ 08855-0849 arxiv:cond-mat/9406049v1

More information

Materials 218/UCSB: Phase transitions and polar materials

Materials 218/UCSB: Phase transitions and polar materials Materials 218/UCSB: Phase transitions and polar materials Ram Seshadri (seshadri@mrl.ucsb.edu) Background: Intrinsic stability of thermodynamic systems (after H. B. Callen, Thermodynamics and an introduction

More information

Piezoelectric Response from Rotating Polarization

Piezoelectric Response from Rotating Polarization Piezoelectric Response from Rotating Polarization Huaxiang Fu and R. E. Cohen Carnegie Institution of Washington, 5251 Broad Branch Road, N.W., Washington D.C. 20015 Abstract. Piezoelectric response induced

More information

Chapter 7 Ionic And Metallic Bonding Answer Key Pearson Education

Chapter 7 Ionic And Metallic Bonding Answer Key Pearson Education Chapter 7 Ionic And Metallic Bonding Answer Key Pearson Education CHAPTER 7 IONIC AND METALLIC BONDING ANSWER KEY PEARSON EDUCATION PDF - Are you looking for chapter 7 ionic and metallic bonding answer

More information

3.320 Atomistic Modeling of Materials Spring 2005 Solution set 3: First-principles energy methods II

3.320 Atomistic Modeling of Materials Spring 2005 Solution set 3: First-principles energy methods II 1 3.320 Atomistic Modeling of Materials Spring 2005 Solution set 3: First-principles energy methods II Problem 1 (50 pts): Cobalt in HCP and FCC structures. k -point mesh : Fig. 1 (a) (b) (c) The dashed

More information

Jaguar DFT Optimizations and Transition State Searches

Jaguar DFT Optimizations and Transition State Searches Jaguar DFT Optimizations and Transition State Searches Density Functional Theory (DFT) is a quantum mechanical (QM) method that gives results superior to Hartree Fock (HF) in less computational time. A

More information

G. Ravichandran Aeronautics & Mechanical Engineering Graduate Aeronautical Laboratories California Institute of Technology

G. Ravichandran Aeronautics & Mechanical Engineering Graduate Aeronautical Laboratories California Institute of Technology Multi-Disciplinary University Initiative Army Research Office Engineering Microstructural Complexity in Ferroelectric Devices Mechanical Characterization G. Ravichandran Aeronautics & Mechanical Engineering

More information

Ferroelectricity and Antiferroelectricity in Elemental Group-V Monolayer Materials

Ferroelectricity and Antiferroelectricity in Elemental Group-V Monolayer Materials Ferroelectricity and Antiferroelectricity in Elemental Group-V Monolayer Materials Chengcheng Xiao 1, Fang Wang 1, Shengyuan A. Yang 2, Yunhao Lu 1 * 1 State Key Laboratory of Silicon Materials, School

More information

ON SITE SYSTEMS Chemical Safety Assistant

ON SITE SYSTEMS Chemical Safety Assistant ON SITE SYSTEMS Chemical Safety Assistant CS ASSISTANT WEB USERS MANUAL On Site Systems 23 N. Gore Ave. Suite 200 St. Louis, MO 63119 Phone 314-963-9934 Fax 314-963-9281 Table of Contents INTRODUCTION

More information

Study the Effect of Dopants on Structural and Electrical Properties of BaTiO 3 Perovskite Ceramics

Study the Effect of Dopants on Structural and Electrical Properties of BaTiO 3 Perovskite Ceramics International Journal of Pure and Applied Physics. ISSN 0973-1776 Volume 13, Number 1 (2017), pp. 101-107 Research India Publications http://www.ripublication.com Study the Effect of Dopants on Structural

More information

FleXScan User Guide. for version 3.1. Kunihiko Takahashi Tetsuji Yokoyama Toshiro Tango. National Institute of Public Health

FleXScan User Guide. for version 3.1. Kunihiko Takahashi Tetsuji Yokoyama Toshiro Tango. National Institute of Public Health FleXScan User Guide for version 3.1 Kunihiko Takahashi Tetsuji Yokoyama Toshiro Tango National Institute of Public Health October 2010 http://www.niph.go.jp/soshiki/gijutsu/index_e.html User Guide version

More information

COMPUTATIONAL TOOL. Fig. 4.1 Opening screen of w2web

COMPUTATIONAL TOOL. Fig. 4.1 Opening screen of w2web CHAPTER -4 COMPUTATIONAL TOOL Ph.D. Thesis: J. Maibam CHAPTER: 4 4.1 The WIEN2k code In this work, all the calculations presented are performed using the WIEN2k software package (Blaha et al., 2001). The

More information

Table of Contents. Table of Contents MoS2 nanotubes

Table of Contents. Table of Contents MoS2 nanotubes Table of Contents Table of Contents MoS nanotubes 1 QuantumATK Try it! QuantumATK Contact Docs» Tutorials» QuantumATK tasks and workflows» MoS nanotubes MoS nanotubes Note Links: DFTB, DFTB model in QuantumATK,

More information

Mnova Software for Analyzing Reaction Monitoring NMR Spectra

Mnova Software for Analyzing Reaction Monitoring NMR Spectra Mnova Software for Analyzing Reaction Monitoring NMR Spectra Version 10 Chen Peng, PhD, VP of Business Development, US & China Mestrelab Research SL San Diego, CA, USA chen.peng@mestrelab.com 858.736.4563

More information

Become a Microprobe Power User Part 2: Qualitative & Quantitative Analysis

Become a Microprobe Power User Part 2: Qualitative & Quantitative Analysis Become a Microprobe Power User Part 2: Qualitative & Quantitative Analysis Mike Spilde Spring IOM Seminar February 5, 2008 Qualitative Analysis Why use qualitative scans? Elemental ID (especially trace

More information

Classification of Dielectrics & Applications

Classification of Dielectrics & Applications Classification of Dielectrics & Applications DIELECTRICS Non-Centro- Symmetric Piezoelectric Centro- Symmetric Pyroelectric Non- Pyroelectric Ferroelectrics Non-Ferroelectric Piezoelectric Effect When

More information

Ethene. Introduction. The ethene molecule is planar (i.e. all the six atoms lie in the same plane) and has a high degree of symmetry:

Ethene. Introduction. The ethene molecule is planar (i.e. all the six atoms lie in the same plane) and has a high degree of symmetry: FY1006 Innføring i kvantefysikk og TFY4215 Kjemisk fysikk og kvantemekanikk Spring 2012 Chemical Physics Exercise 1 To be delivered by Friday 27.04.12 Introduction Ethene. Ethylene, C 2 H 4, or ethene,

More information

M61 1 M61.1 PC COMPUTER ASSISTED DETERMINATION OF ANGULAR ACCELERATION USING TORQUE AND MOMENT OF INERTIA

M61 1 M61.1 PC COMPUTER ASSISTED DETERMINATION OF ANGULAR ACCELERATION USING TORQUE AND MOMENT OF INERTIA M61 1 M61.1 PC COMPUTER ASSISTED DETERMINATION OF ANGULAR ACCELERATION USING TORQUE AND MOMENT OF INERTIA PRELAB: Before coming to the lab, you must write the Object and Theory sections of your lab report

More information

Phase Transitions in Strontium Titanate

Phase Transitions in Strontium Titanate Phase Transitions in Strontium Titanate Xinyue Fang Department of Physics, University of Illinois at Urbana-Champaign Abstract Strontium Titanate SrTiO 3 (STO) is known to undergo an antiferrodistortive

More information

Synthesis and Ferroelectric Properties of KNO 3 films

Synthesis and Ferroelectric Properties of KNO 3 films Synthesis and Ferroelectric Properties of KNO 3 films Shahid Ramay and Muhammad Sabieh Anwar LUMS School of Science and Engineering Friday, August, 20, 2010 Potassium nitrate (KNO 3 ) shows ferroelectric

More information

EXPERIMENT 7: ANGULAR KINEMATICS AND TORQUE (V_3)

EXPERIMENT 7: ANGULAR KINEMATICS AND TORQUE (V_3) TA name Lab section Date TA Initials (on completion) Name UW Student ID # Lab Partner(s) EXPERIMENT 7: ANGULAR KINEMATICS AND TORQUE (V_3) 121 Textbook Reference: Knight, Chapter 13.1-3, 6. SYNOPSIS In

More information

Winmostar tutorial LAMMPS Melting point V X-Ability Co,. Ltd. 2017/8/17

Winmostar tutorial LAMMPS Melting point V X-Ability Co,. Ltd. 2017/8/17 Winmostar tutorial LAMMPS Melting point V7.025 X-Ability Co,. Ltd. question@winmostar.com Contents Configure I. Build solid phase II. Equilibration of solid phase III. Equilibration of liquid phase IV.

More information

QUANTUM CHEMISTRY WITH GAUSSIAN : A VERY BRIEF INTRODUCTION (PART 2)

QUANTUM CHEMISTRY WITH GAUSSIAN : A VERY BRIEF INTRODUCTION (PART 2) QUANTUM CHEMISTRY WITH GAUSSIAN : A VERY BRIEF INTRODUCTION (PART 2) TARAS V. POGORELOV AND MIKE HALLOCK SCHOOL OF CHEMICAL SCIENCES, UIUC This tutorial continues introduction to Gaussian [2]. Here we

More information

From 180º stripe domains to more exotic patterns of polarization in ferroelectric nanostructures. A first principles view

From 180º stripe domains to more exotic patterns of polarization in ferroelectric nanostructures. A first principles view From 180º stripe domains to more exotic patterns of polarization in ferroelectric nanostructures. A first principles view Pablo Aguado-Puente Javier Junquera Ferroelectricity: Basic definitions Existence

More information

INSTRUCTIONAL MANUAL. CURIE TEMPERATURE MEASUREMENT (For Ferroelectric Materials) Applied Science Department NITTTR, Sector-26, Chandigarh

INSTRUCTIONAL MANUAL. CURIE TEMPERATURE MEASUREMENT (For Ferroelectric Materials) Applied Science Department NITTTR, Sector-26, Chandigarh INSTRUTIONAL MANUAL URIE TEMPERATURE MEASUREMENT (For Ferroelectric Materials) Applied Science Department NITTTR, Sector-26, handigarh urie Temperature Measurement OBJETIE: Measurement of urie Temperature

More information

Supplementary Information

Supplementary Information Supplementary Information Supplementary Figure 1: After structural optimization of the CH 3 NH 3 PbI 3 unit cell, the resulting relaxed volumes for three distinct orientation of the MA molecules are shown.

More information

Earth Materials Lab 2 - Lattices and the Unit Cell

Earth Materials Lab 2 - Lattices and the Unit Cell Earth Materials Lab 2 - Lattices and the Unit Cell Unit Cell Minerals are crystallographic solids and therefore are made of atoms arranged into lattices. The average size hand specimen is made of more

More information

Phonon Dispersion, Interatomic Force Constants Thermodynamic Quantities

Phonon Dispersion, Interatomic Force Constants Thermodynamic Quantities Phonon Dispersion, Interatomic Force Constants Thermodynamic Quantities Umesh V. Waghmare Theoretical Sciences Unit J N C A S R Bangalore ICMR OUTLINE Vibrations and interatomic force constants (IFC) Extended

More information

Experiment 2a Models of the Solid State*

Experiment 2a Models of the Solid State* Experiment 2a Models of the Solid State* *This lab is adapted from solid-state labs offered at Purdue and Rice Universities. Introduction The structures of metals and simple ionic solids are prototypes

More information

v Prerequisite Tutorials GSSHA WMS Basics Watershed Delineation using DEMs and 2D Grid Generation Time minutes

v Prerequisite Tutorials GSSHA WMS Basics Watershed Delineation using DEMs and 2D Grid Generation Time minutes v. 10.1 WMS 10.1 Tutorial GSSHA WMS Basics Creating Feature Objects and Mapping Attributes to the 2D Grid Populate hydrologic parameters in a GSSHA model using land use and soil data Objectives This tutorial

More information

First Principles Studies on the Electronic Structure and Band Structure of Paraelectric SrTiO 3 by Different Approximations

First Principles Studies on the Electronic Structure and Band Structure of Paraelectric SrTiO 3 by Different Approximations Journal of Modern Physics, 2011, 2, 934-943 doi:10.4236/jmp.2011.29111 Published Online September 2011 (http://www.scirp.org/journal/jmp) First Principles Studies on the Electronic Structure and Band Structure

More information

Theory of structural response to macroscopic electric fields in ferroelectric systems

Theory of structural response to macroscopic electric fields in ferroelectric systems PHYSICAL REVIEW B 66, 104108 2002 Theory of structural response to macroscopic electric fields in ferroelectric systems Na Sai, Karin M. Rabe, and David Vanderbilt Department of Physics and Astronomy,

More information

Supplementary Information

Supplementary Information Supplementary Information Supplementary Figure 1: Electronic Kohn-Sham potential profile of a charged monolayer MoTe 2 calculated using PBE-DFT. Plotted is the averaged electronic Kohn- Sham potential

More information

SECOND PUBLIC EXAMINATION. Honour School of Physics Part C: 4 Year Course. Honour School of Physics and Philosophy Part C C3: CONDENSED MATTER PHYSICS

SECOND PUBLIC EXAMINATION. Honour School of Physics Part C: 4 Year Course. Honour School of Physics and Philosophy Part C C3: CONDENSED MATTER PHYSICS A11046W1 SECOND PUBLIC EXAMINATION Honour School of Physics Part C: 4 Year Course Honour School of Physics and Philosophy Part C C3: CONDENSED MATTER PHYSICS TRINITY TERM 2015 Wednesday, 17 June, 2.30

More information

ab initio Lattice Vibrations: Calculating the Thermal Expansion Coeffcient Felix Hanke & Martin Fuchs June 30, 2009 This afternoon s plan

ab initio Lattice Vibrations: Calculating the Thermal Expansion Coeffcient Felix Hanke & Martin Fuchs June 30, 2009 This afternoon s plan ab initio Lattice Vibrations: Calculating the Thermal Expansion Coeffcient Felix Hanke & Martin Fuchs June 3, 29 This afternoon s plan introductory talk Phonons: harmonic vibrations for solids Phonons:

More information

2.3 Band structure and lattice symmetries: example of diamond

2.3 Band structure and lattice symmetries: example of diamond 2.2.9 Product of representaitons Besides the sums of representations, one can also define their products. Consider two groups G and H and their direct product G H. If we have two representations D 1 and

More information

Effect of substrate-induced strains on the spontaneous polarization of epitaxial BiFeO 3 thin films

Effect of substrate-induced strains on the spontaneous polarization of epitaxial BiFeO 3 thin films JOURNAL OF APPLIED PHYSICS 11, 11415 27 Effect of substrate-induced strains on the spontaneous polarization of epitaxial 3 thin films J. X. Zhang, a Y. L. Li, Y. Wang, Z. K. Liu, and L. Q. Chen Department

More information

Chemistry 14CL. Worksheet for the Molecular Modeling Workshop. (Revised FULL Version 2012 J.W. Pang) (Modified A. A. Russell)

Chemistry 14CL. Worksheet for the Molecular Modeling Workshop. (Revised FULL Version 2012 J.W. Pang) (Modified A. A. Russell) Chemistry 14CL Worksheet for the Molecular Modeling Workshop (Revised FULL Version 2012 J.W. Pang) (Modified A. A. Russell) Structure of the Molecular Modeling Assignment The molecular modeling assignment

More information

Materials that you may find helpful when working through this exercise

Materials that you may find helpful when working through this exercise Detailed steps illustrating how to use VASP on the Suns in Fitz 177 For use in lab: 11/10/2009 (Original file by Dr. Rachel Getman, 11/18/2007. Editted for use by Dorrell McCalman 11/09/2009.) Note on

More information

An Introduction to Lattice Vibrations

An Introduction to Lattice Vibrations An Introduction to Lattice Vibrations Andreas Wacker 1 Mathematical Physics, Lund University November 3, 2015 1 Introduction Ideally, the atoms in a crystal are positioned in a regular manner following

More information

Ferroelectric Materials

Ferroelectric Materials Ferroelectric Materials The permanent electric dipole moment possessed by all pyroelectric [polar] materials may, in certain cases, be reoriented by the application of an electric field. Such crystals

More information

Vibrations of Carbon Dioxide and Carbon Disulfide

Vibrations of Carbon Dioxide and Carbon Disulfide Vibrations of Carbon Dioxide and Carbon Disulfide Purpose Vibration frequencies of CO 2 and CS 2 will be measured by Raman and Infrared spectroscopy. The spectra show effects of normal mode symmetries

More information

T. Interface Energy of Metal-Ceramic Interface Co-WC Using ab initio Thermodynamics

T. Interface Energy of Metal-Ceramic Interface Co-WC Using ab initio Thermodynamics Application Note T. Using ab initio Thermodynamics Introduction In many metal-ceramic composites the interface between the metallic and ceramic phases determines the mechanical properties of the material.

More information

Electronic structure of barium titanate : an abinitio DFT study. Hong-Jian Feng, Fa-Min Liu

Electronic structure of barium titanate : an abinitio DFT study. Hong-Jian Feng, Fa-Min Liu Electronic structure of barium titanate : an abinitio DFT study Hong-Jian Feng, Fa-Min Liu Department of Physics, School of Sciences, Beijing University of Aeronautics & Astronautics, Beijing 183, P. R.

More information

Fundamentals and applications of Density Functional Theory Astrid Marthinsen PhD candidate, Department of Materials Science and Engineering

Fundamentals and applications of Density Functional Theory Astrid Marthinsen PhD candidate, Department of Materials Science and Engineering Fundamentals and applications of Density Functional Theory Astrid Marthinsen PhD candidate, Department of Materials Science and Engineering Outline PART 1: Fundamentals of Density functional theory (DFT)

More information

A Brief Introduction To. GRTensor. On MAPLE Platform. A write-up for the presentation delivered on the same topic as a part of the course PHYS 601

A Brief Introduction To. GRTensor. On MAPLE Platform. A write-up for the presentation delivered on the same topic as a part of the course PHYS 601 A Brief Introduction To GRTensor On MAPLE Platform A write-up for the presentation delivered on the same topic as a part of the course PHYS 601 March 2012 BY: ARSHDEEP SINGH BHATIA arshdeepsb@gmail.com

More information

First principles studies of the Born effective charges and electronic dielectric tensors for the relaxor PMN (PbMg 1/3 Nb 2/3 O 3 )

First principles studies of the Born effective charges and electronic dielectric tensors for the relaxor PMN (PbMg 1/3 Nb 2/3 O 3 ) First principles studies of the Born effective charges and electronic dielectric tensors for the relaxor PMN (PbMg 1/3 Nb 2/3 O 3 ) Narayani Choudhury 1, R. E. Cohen 2 and Eric J. Walter 3 1 Solid State

More information

QUANTUM CHEMISTRY PROJECT 3: PARTS B AND C

QUANTUM CHEMISTRY PROJECT 3: PARTS B AND C Chemistry 460 Fall 2017 Dr. Jean M. Standard November 6, 2017 QUANTUM CHEMISTRY PROJECT 3: PARTS B AND C PART B: POTENTIAL CURVE, SPECTROSCOPIC CONSTANTS, AND DISSOCIATION ENERGY OF DIATOMIC HYDROGEN (20

More information

PHY 111L Activity 2 Introduction to Kinematics

PHY 111L Activity 2 Introduction to Kinematics PHY 111L Activity 2 Introduction to Kinematics Name: Section: ID #: Date: Lab Partners: TA initials: Objectives 1. Introduce the relationship between position, velocity, and acceleration 2. Investigate

More information

Hartree Fock Studies of the Ferroelectric Perovskites

Hartree Fock Studies of the Ferroelectric Perovskites Presented at the: Fifth Williamsburg Workshop on First Principles Calculations for Ferroelectrics, February 1 4, Williamsburg, VA, USA arxiv:cond-mat/9803002v2 [cond-mat.mtrl-sci] 14 Mar 1998 Hartree Fock

More information

Designing a Quilt with GIMP 2011

Designing a Quilt with GIMP 2011 Planning your quilt and want to see what it will look like in the fabric you just got from your LQS? You don t need to purchase a super expensive program. Try this and the best part it s FREE!!! *** Please

More information

Calculating NMR Chemical Shifts for beta-ionone O

Calculating NMR Chemical Shifts for beta-ionone O Calculating NMR Chemical Shifts for beta-ionone O Molecular orbital calculations can be used to get good estimates for chemical shifts. In this exercise we will calculate the chemical shifts for beta-ionone.

More information

Tutorial. Getting started. Sample to Insight. March 31, 2016

Tutorial. Getting started. Sample to Insight. March 31, 2016 Getting started March 31, 2016 Sample to Insight CLC bio, a QIAGEN Company Silkeborgvej 2 Prismet 8000 Aarhus C Denmark Telephone: +45 70 22 32 44 www.clcbio.com support-clcbio@qiagen.com Getting started

More information

Virtual NanoLab. Tutorial. Version

Virtual NanoLab. Tutorial. Version Virtual NanoLab Tutorial Version 2008.10 Virtual NanoLab: Tutorial Version 2008.10 Copyright 2008 QuantumWise A/S Virtual NanoLab License to Use Agreement Licensor QuantumWise A/S Gyvelvej 20 Solrød Strand

More information