A General Kinetic-Optical Model for Solid-State Reactions Involving the Nano Kirkendall Effect. The Case of Copper Nanoparticle Oxidation

Size: px
Start display at page:

Download "A General Kinetic-Optical Model for Solid-State Reactions Involving the Nano Kirkendall Effect. The Case of Copper Nanoparticle Oxidation"

Transcription

1 Supporting Information A General Kinetic-Optical Model for Solid-State Reactions Involving the Nano Kirkall Effect. The Case of Copper Nanoparticle Oxidation Mariano D. Susman, Alexander Vaskevich, * Israel Rubinstein * Department of Materials and Interfaces, Weizmann Institute of Science, Rehovot 7, Israel * Corresponding author. alexander.vaskevich@weizmann.ac.il israel.rubinstein@weizmann.ac.il

2 t =, δ = t, <δ < ) Air t =, δ = Air Cu a Oxide a a Figure S. Schematic description of Cu O NP formation according to the Valensi-Carter (VC) model, showing (top) the NP geometric conformation, (middle) the concentration profiles, and (bottom) the species flow, as a function of the time or conversion fraction (progressing from left to right). Full lines indicate the behavior of the species, assumed by the model.

3 t =, δ = t, <δ < ) Air t =, δ = Air Cu a v a a a Figure S. Schematic description of Cu O NP formation according to the nano Kirkenall effect (NKE) model, showing (top) the NP geometric conformation, (medium) the concentration profiles, and (bottom) the species flow, as a function of the time or conversion fraction (progressing from left to right). Full lines indicate the behavior of the species, assumed by the model. Note that the outgoing flow of Cu is compensated by inward flow of vacancies, as O - is assumed to negligibly diffuse through the oxide layer. A B Figure S. Schematic description of Cu O NP formation observed from (A) a static frame-of-reference centered at, and (B) a moving oxide lattice frame-of-reference, free to advance with any Kirkall shift (given by ), which deps on the combination of and values. The inward and outward growths, actually taking place at the oxide boundaries, are assumed to occur at the Kirkall surface. For =, scheme B reduces to scheme A. Note that the oxidation front may be considered to coincide with the Kirkall surface ( = ).

4 Inward vacancy diffusion Outward vacancy diffusion VC Outward oxide formation Inward oxide formation NKE Z- Z/ Figure S. The various oxidation regimes, for different combinations of and values. Note that the general model accounts for all situations. Restricted cases where no Kirkall shift occurs ( =) are indicated by the blue line. Red circles indicate the location of the oxidation front (or Kirkall surface). Dotted circles indicate the location of the initial particle surface (at ). A) a = nm

5 B) a = 9 nm. x x. x.. 8 x. x.. 8 x 8 7 x x x 8 C) a = nm x x... x 8 x... x 8 x 8 8 x 8 8 x 8 8 x Figure S., scattering and extinction cross-sections for Cu NPs of (A), (B) 9 and (C) nm initial diameter, as a function of the conversion fraction (from to, indicated), and for different values.

6 A. x B x Figure S. cross-sections for Cu NPs of 9 nm initial diameter undergoing oxidation ( = ), as a function of the conversion fraction (from to, indicated). Results obtained with (A) the Matlab script (quasi-static approximation), and with (B) MieLab.. software, using the same medium dielectric constant (., corresponding to air/glass supported NPs) and geometric parameters, are presented and can be compared.. x x... x Figure S7. cross-sections for Cu NPs of 9 nm initial diameter undergoing oxidation to CuO, as a function of the conversion fraction (from to, indicated), and for different values.

7 Figure S8. cross-sections for nm (initial diameter) Ag NPs undergoing oxidation to Ag O ( =), as a function of the conversion fraction (from to, indicated). 7

8 Matlab script % METAL NANOPARTICLE OXIDATION % Mie solutions for core-shell spherical nanoparticles % under the quasi-static approximation % -- General kinetic model considering the NKE, without Kirkall shift -- % Calculations as a function of time % % In this script, spherical metal NPs with a given normal size distribution % react according to a general kinetic model, where the NKE is considered. % The standard deviation of the distribution can % be set for the particular size distribution in the system under study. % Bulk properties of the materials have to be defined (density and formula % weight), as well as the stoichiometric coefficients of the reaction. % The parameters phi and k, have to be set in the script for defining the % extent of core contraction and the reaction rate. % A Mie scattering model (in the quasi-static approximation) of spherical % core-shell particles was used to model the overall optical behavior of % the evolving core-shell NP system. % An Effective Medium Approximation (EMA) (Maxwell-Garnett approximation) % was used to model the optical properties of the core under vacancy % accumulation. % A Kreibig's correction is applied for the size depent metal dielectric % constant (relevant at the low size limit). Plasma frequency, % Fermi velocity, and bulk damping constant have to be set. % % The files containing the bulk dielectric constants of metal () and oxide % () have to be in the format: st column:, nd column: n, % rd column: k, separated by tabulations. % % Calculations are performed as a function of the reaction time, according to % the integral reaction model. % clc clear all close all lambda=(:.:).'; % in nm %% PROPERTIES OF THE MATERIALS %% Dielectric constant of the core % For Cu: Jonhnson and Christy's bulk data (Cu-JC.txt) filename='cu-jc.txt'; % Select the appropriate core material file. fid=fopen(filename); fgetl(fid); tmp=fscanf(fid,'%g %g %g',[,inf]); fclose(fid); n=interp(tmp(,:),tmp(,:),lambda,'spline'); % n - metal (interpolated) k=interp(tmp(,:),tmp(,:),lambda,'spline'); % k - metal (interpolated) reps=n.^-k.^; ieps=*n.*k; eps=reps+i*ieps; % Real part epsilon - metal % Imaginary part of epsilon - metal % Complex dielectric constant of metal clear n; clear k; %% Dielectric constant of the shell % For CuO: Malerba et al. data (CuO-Malerba.txt) filename='cuo-malerba.txt'; % Select the appropriate shell material file. 8

9 fid=fopen(filename); fgetl(fid); tmp=fscanf(fid,'%g %g %g',[,inf]); fclose(fid); n=interp(tmp(,:),tmp(,:),lambda,'spline'); % n - oxide (interpolated) k=interp(tmp(,:),tmp(,:),lambda,'spline'); % k - oxide (interpolated) reps=n.^-k.^; ieps=*n.*k; % Real part of epsilon - oxide % Imaginary part of epsilon - oxide eps=reps+i*ieps; % Complex dielectric constant of oxide clear n; clear k; %% Dielectric constant of medium % The refractive index of the medium of the supported NPs is roughly % estimated by computing the weighted average of the refractive indices of % glass (~%) and air (~7 %), where the weights are taken to % approximate the proportion of the NP surfaces area in contact with each % medium. % Refractive index of borosilicate glass coverslips is., according to % n_m=.*.+.7*; epsm=n_m^; % Average RI of the medium. % Dielectric constant of the medium clear reps; clear reps; clear ieps; clear ieps; clear fid; clear tmp; clear tline; clear filename; %% Bulk densities and formula weights % Bulk densities dens = 8.9; % For Cu (g cm-) dens =.; % For CuO (g cm-) % Formula weights FW =.; % For Cu (g mol-) FW =.9; % For CuO (g mol-) eta=; % Stoichiometric coefficient Z=(dens*FW)/(dens*FW*eta); % Pilling Bethword factor % Volume of product formed per unit of volume of core % material reacted. Has to be Z> (volume expansion). %% Geometric parameters a_ = ; % Initial metal NP radius (in nm) (integers only). a sigma = ; % Std. deviation of the radius (in nm)(integers only). if a sigma == a_x = a_; a_y = ; else a_x = ::a_+*a sigma; a_y = normpdf(a_x,a_,a sigma)/sum(normpdf(a_x,a_,a sigma)); % Distribution of NP radii, +/- standard deviations wide %% General kinetic model 9

10 phi=.; % Proportion of the process which leads to core-contraction. %(=<phi=<). conv=:.:; % Conversion fractions for evaluating the general model. if phi>; ad_valcar=(z-(phi.*(-(phi-z).*conv).^(/))-(z-phi).*(-phi*conv).^(/))..../(*(z-phi)*phi); % This equation is only defined for <phi<=. elseif phi==; ad_valcar=((/)*z.*conv-(+z.*conv).^(/)+)./(*z); % For phi=, the function needs to be defined at this point. valcar(:,)=conv'; valcar(:,)=ad_valcar'; clear ad_valcar; %% Application of the kinetic model k_reac=7; % Oxidation rate constant time=[.,,,::,::]; % (in min) % Choose times as desired left_term_vc=zeros(length(time),length(a_x)); delta_vc=zeros(length(time),length(a_x)); % Conversion fraction for each NP for i=:length(time) left_term_vc(i,:)=time(i)*k_reac./(a_x.^); % Left VC term for each particle reacting, deping on time. % It is directly related to the conversion fraction. for j=:length(a_x); if left_term_vc(i,j)>=(z-z^(/))/(*(z-)) left_term_vc(i,j)=(z-z^(/))/(*(z-)); delta_vc(i,j)=interp(valcar(:,),valcar(:,),left_term_vc(i,j),'spline'); if isnan(delta_vc(i,j))== delta_vc(i,j)=; delta_vc=delta_vc'; delta_vc_ens=zeros(length(time),); % Conversion fraction of the ensemble for i=:length(time) for j=:length(a_x) delta_vc_ens(i,)=sum(a_x(,j).^.*delta_vc(j,i).*a_y(,j))./sum(a_x(,j).^.*a_y(,j)); [height_r,width_r]=size(delta_vc); a=zeros(height_r,width_r); a=zeros(height_r,width_r); for j=:length(a_x) % Distributions of a = radii (metal-shell) and a = radius (shell-air) % for the distribution of NPs reacting. a(j,:)= a_x(j)'*(-phi*delta_vc(j,:)).^(/); %. a(j,:)= a_x(j)'*(-phi*delta_vc(j,:)+z.*delta_vc(j,:)).^(/); f=(a./a).^; % Volume fraction

11 %% Corrections of the dielectric constants %% Kreibig's correction % "Modelling the optical response of gold nanoparticles" % Chem. Soc. Rev., 8, 7, 79 8 % For Cu wp = 8.8; % Plasma frequency (ev) gamma =.9*^-; % Bulk damping constant (ev) vf =.; % Fermi velocity % vf =(.7*^ m/s)* h *^9 nm/m [ev.nm] % with h=.7*^- ev.s % The size effect is considered by modelling the damping constant (gamma) % as % gamma=gamma(bulk)+a*vf/r % where vf is the Fermi velocity % r is the radius of the particle % A is a dimensionless geometrical parameter assumed to be. % as vf/r has Hz units, this is converted to ev units by multiplying the % Fermi velocity (in m/s) by the Planck constant (in ev.s units). freq=9.8./lambda; % Light frequency % (in ev units) [E=hbar*w=h*w/(pi)] % since(nm) = 9.8/E(eV) freq_a=zeros(length(lambda),height_r,width_r); eps_a=zeros(length(lambda),height_r,width_r); eps_a=zeros(length(lambda),height_r,width_r); epsm_a=zeros(length(lambda),height_r,width_r); for i=:height_r; for j=:width_r freq_a(:,i,j)=freq; eps_a(:,i,j)=eps; eps_a(:,i,j)=eps; epsm_a(:length(lambda),i,j)=epsm; factor=zeros(length(lambda),height_r,width_r); for l=:length(lambda) factor(l,:,:)=gamma+vf./a; eps_a=eps_a... +(wp^./(freq_a.^+i*freq_a.*gamma))... -(wp^./(freq_a.^+i*freq_a.*factor)); %% Effective Medium Approximation (EMA) % To describe the formation of inclusions in the core due to Kirkall % effect. delta_prime_vc=zeros(length(lambda),height_r,width_r); for i=:length(lambda); for j=:height_r delta_prime_vc(i,j,:)=(-phi).*delta_vc(j,:)./(-phi.*delta_vc(j,:)); % corrected by the fraction that goes to the core-contraction, % and therefore leads not to inclusions. for h=:width_r if isnan(delta_prime_vc(i,j,h))== delta_prime_vc(i,j,h)=; % Maxwell-Garnett model %

12 eps_a=eps_a.*(((*(-delta_prime_vc).*eps_a+(+*delta_prime_vc).*epsm_a))./... ((+delta_prime_vc).*eps_a+(-delta_prime_vc).*epsm_a)); %% Mie scattering model (quasi-static approximation) %% Dipole polarizability (alpha) for core-shells in the quasi-static limit f_a=zeros(length(lambda),height_r,width_r); for ii=:length(lambda); f_a(ii,:height_r,:width_r)=f; coef=*pi*a.^; beta=(((eps_a-epsm_a).*(eps_a+*eps_a))+(eps_a- eps_a).*(epsm_a+*eps_a).*f_a)./... ((eps_a+*epsm_a).*(eps_a+*eps_a)+(*(eps_a-epsm_a).*(eps_a-eps_a)).*f_a); alpha=zeros(length(lambda),height_r,width_r); for i=:width_r for j=:height_r alpha(:,j,i)=coef(j,i)*beta(:,j,i); clear i; clear j; %% Calculation of scattering, absorption and extinction coefficients k=*pi*n_m./lambda; % Wavenumber factor=k.^/(*pi); factor=abs(alpha).^; Cscatt=zeros(length(lambda),height_r,width_r); Cabs=zeros(length(lambda),height_r,width_r); Cext=zeros(length(lambda),height_r,width_r); for i=:width_r for j=:height_r Cscatt(:,j,i)=factor.*factor(:,j,i); Cabs(:,j,i)=(k.*abs(imag(alpha(:,j,i)))); Cext(:,j,i)=Cabs(:,j,i)+Cscatt(:,j,i); % For considering the normal distribution of sizes: Cscatt_dist=zeros(length(lambda),width_r); Cabs_dist=zeros(length(lambda),width_r); Cext_dist=zeros(length(lambda),width_r); for h=:height_r for w=:width_r if a sigma == Cscatt_dist(:,w) = Cscatt(:,h,w); Cabs_dist(:,w) = Cabs(:,h,w); Cext_dist(:,w) = Cext(:,h,w); else Cscatt_dist(:,w) = Cscatt(:,h,w) *a_y(,h)'; Cabs_dist(:,w) = Cabs(:,h,w) *a_y(,h)'; Cext_dist(:,w) = Cext(:,h,w) *a_y(,h)';

13 %% Data analysis and plots %% Maxima locations as a function of time ext_max_cext=zeros(length(time),); lambda_max_cext=zeros(length(time),); % min_lambda = ; % Define the minimal wavelength from where to start % % analyzing spectra. This excludes assigning maxima to absorption % % bands not corresponding to plasmon extinctions but to oxide % % absorptions, likely occurring at lower wavelengths. for j=:length(time); % This excludes the first and last r values defined. try [ext_max_cext(j),lambda_max_cext(j)]=findpeaks(cext_dist(:,j), 'SORTSTR', 'desc', 'NPEAKS',); lambda_max_cext(j)=lambda(lambda_max_cext(j)); catch exception ext_max_cext(j)=nan; lambda_max_cext(j)=nan; %% Plots scrsz = get(,'screensize'); figure('position',[ scrsz()*/ scrsz()/]); subplot(,,[,,,]); plot(lambda,cext_dist,'linewidth',); set(gcf,'color','w'); set(gca,'color','w','fontsize',); xlabel('','fontsize',,'fontangle','italic','fontweight','bold'); ylabel('','fontsize',,'fontangle','italic','fontweight','bold'); xlim([ ]); g=leg(cellstr(numstr(time')),'location','northeastoutside','fontsize',); set(g,'box','off'); subplot(,,); plot(time,lambda_max_cext(:length(time)),'--o','linewidth',,'markersize',8); set(gca,'color','w','fontsize',,'xscale','log','xtick',[.,,,,,]); xlabel('time (min)','fontsize',,'fontangle','italic','fontweight','bold'); ylabel('wavelength@max (nm)','fontsize',,'fontangle','italic','fontweight','bold'); xlim([.,max(time)]); ylim([,9]); subplot(,,); plot(time,ext_max_cext(:length(time)),'--o','linewidth',,'markersize',8); set(gca,'color','w','fontsize',,'xscale','log','xtick',[.,,,,,]); xlabel('time (min)','fontsize',,'fontangle','italic','fontweight','bold'); ylabel('@max','fontsize',,'fontangle','italic','fontweight','bold'); xlim([.,max(time)]);

Plasmonic properties and sizing of core-shell Cu-Cu 2 O nanoparticles fabricated by femtosecond laser ablation in liquids ABSTRACT

Plasmonic properties and sizing of core-shell Cu-Cu 2 O nanoparticles fabricated by femtosecond laser ablation in liquids ABSTRACT Plasmonic properties and sizing of core-shell Cu-Cu O nanoparticles fabricated by femtosecond laser ablation in liquids J. M. J. Santillán 1, F. A. Videla 1,, D. C. Schinca 1, and L. B. Scaffardi 1, 1

More information

Optical and Photonic Glasses. Lecture 39. Non-Linear Optical Glasses III Metal Doped Nano-Glasses. Professor Rui Almeida

Optical and Photonic Glasses. Lecture 39. Non-Linear Optical Glasses III Metal Doped Nano-Glasses. Professor Rui Almeida Optical and Photonic Glasses : Non-Linear Optical Glasses III Metal Doped Nano-Glasses Professor Rui Almeida International Materials Institute For New Functionality in Glass Lehigh University Metal-doped

More information

Simulated Study of Plasmonic Coupling in Noble Bimetallic Alloy Nanosphere Arrays

Simulated Study of Plasmonic Coupling in Noble Bimetallic Alloy Nanosphere Arrays CHAPTER 4 Simulated Study of Plasmonic Coupling in Noble Bimetallic Alloy Nanosphere Arrays 4.1 Introduction In Chapter 3, the noble bimetallic alloy nanosphere (BANS) of Ag 1-x Cu x at a particular composition

More information

Supporting Information

Supporting Information Supporting Information Improved Working Model for Interpreting the Excitation Wavelength- and Fluence-Dependent Response in Pulsed aser-induced Size Reduction of Aqueous Gold Nanoparticles Daniel Werner

More information

Supplementary information for. plasmonic nanorods interacting with J-aggregates.

Supplementary information for. plasmonic nanorods interacting with J-aggregates. Supplementary information for Approaching the strong coupling limit in single plasmonic nanorods interacting with J-aggregates. by Gülis Zengin, Göran Johansson, Peter Johansson, Tomasz J. Antosiewicz,

More information

Spring 2009 EE 710: Nanoscience and Engineering

Spring 2009 EE 710: Nanoscience and Engineering Spring 009 EE 710: Nanoscience and Engineering Part 10: Surface Plasmons in Metals Images and figures supplied from Hornyak, Dutta, Tibbals, and Rao, Introduction to Nanoscience, CRC Press Boca Raton,

More information

Supporting Online Material. Highly Sensitive Plasmonic Silver Nanorods

Supporting Online Material. Highly Sensitive Plasmonic Silver Nanorods Supporting Online Material Highly Sensitive Plasmonic Silver Nanorods Arpad Jakab, Christina Rosman, Yuriy Khalavka, Jan Becker, Andreas Trügler+, Ulrich Hohenester+, and Carsten Sönnichsen * MAINZ graduate

More information

Localized surface plasmons (Particle plasmons)

Localized surface plasmons (Particle plasmons) Localized surface plasmons (Particle plasmons) ( Plasmons in metal nanostructures, Dissertation, University of Munich by Carsten Sonnichsen, 2001) Lycurgus cup, 4th century (now at the British Museum,

More information

The Dielectric Function of a Metal ( Jellium )

The Dielectric Function of a Metal ( Jellium ) The Dielectric Function of a Metal ( Jellium ) Total reflection Plasma frequency p (10 15 Hz range) Why are Metals Shiny? An electric field cannot exist inside a metal, because metal electrons follow the

More information

Electronic Supplementary Information

Electronic Supplementary Information Electronic Supplementary Material (ESI) for Physical Chemistry Chemical Physics. This journal is the Owner Societies 2014 Electronic Supplementary Information CW-Laser-Induced Morphological Changes of

More information

One-step Solution Processing of Ag, Au and Hybrids for SERS

One-step Solution Processing of Ag, Au and Hybrids for SERS 1 2 3 Supplementary Information One-step Solution Processing of Ag, Au and Pd@MXene Hybrids for SERS 4 5 6 Elumalai Satheeshkumar 1, Taron Makaryan 2, Armen Melikyan 3, Hayk Minassian 4, Yury Gogotsi 2*

More information

7. Localized surface plasmons (Particle plasmons)

7. Localized surface plasmons (Particle plasmons) 7. Localized surface plasmons (Particle plasmons) ( Plasmons in metal nanostructures, Dissertation, University of Munich by Carsten Sonnichsen, 2001) Lycurgus cup, 4th century (now at the British Museum,

More information

Nanophotonics: principle and application. Khai Q. Le Lecture 4 Light scattering by small particles

Nanophotonics: principle and application. Khai Q. Le Lecture 4 Light scattering by small particles Nanophotonics: principle and application Khai Q. Le Lecture 4 Light scattering by small particles Previous lecture Drude model, Drude-Sommerfeld model and Drude-Lorentz model for conducting media (metal):

More information

Diffusion of silver in silicate glass and clustering in hydrogen atmosphere

Diffusion of silver in silicate glass and clustering in hydrogen atmosphere Defect and Diffusion Forum Vols. 7-4 (5) pp. 689-694 online at http://www.scientific.net 5 Trans Tech Publications, Switzerland Diffusion of silver in silicate glass and clustering in hydrogen atmosphere

More information

are the eigenvalues of the permittivity tensor in Cartesian coordinates, written as, 3 " xx + i" xy ( , which gives

are the eigenvalues of the permittivity tensor in Cartesian coordinates, written as, 3  xx + i xy ( , which gives Supplemental Material for Faraday rotation enhancement of gold coated Fe2O3 nanoparticles: Comparison of experiment and theory Raj Kumar Dani, Hongwang Wang, Stefan H. Bossmann, Gary Wysin and Viktor Chikan,

More information

Optical properties of spherical and anisotropic gold shell colloids

Optical properties of spherical and anisotropic gold shell colloids 8 Optical properties of spherical and anisotropic gold shell colloids Core/shell colloids consisting of a metal shell and a dielectric core are known for their special optical properties. The surface plasmon

More information

The effect of surface plasmon resonance on optical response in dielectric (core) metal (shell) nanoparticles

The effect of surface plasmon resonance on optical response in dielectric (core) metal (shell) nanoparticles PRAMANA c Indian Academy of Sciences Vol. 85, No. 6 journal of December 2015 physics pp. 1245 1255 The effect of surface plasmon resonance on optical response in dielectric (core) metal (shell) nanoparticles

More information

Supporting Information

Supporting Information Supporting Information Remarkable Photothermal Effect of Interband Excitation on Nanosecond Laser-induced Reshaping and Size Reduction of Pseudo-spherical Gold Nanoparticles in Aqueous Solution Daniel

More information

Optical cavity modes in gold shell particles

Optical cavity modes in gold shell particles 9 Optical cavity modes in gold shell particles Gold (Au) shell particles with dimensions comparable to the wavelength of light exhibit a special resonance, with a tenfold field enhancement over almost

More information

10. Optics of metals - plasmons

10. Optics of metals - plasmons 1. Optics of metals - plasmons Drude theory at higher frequencies The Drude scattering time corresponds to the frictional damping rate The ultraviolet transparency of metals Interface waves - surface plasmons

More information

Extinction properties of a sphere with negative permittivity and permeability

Extinction properties of a sphere with negative permittivity and permeability PERGAMON Solid State Communications 116 (2000) 411 415 www.elsevier.com/locate/ssc Extinction properties of a sphere with negative permittivity and permeability R. Ruppin* Department of Physics and Applied

More information

EELS, Surface Plasmon and Adsorbate Vibrations

EELS, Surface Plasmon and Adsorbate Vibrations EELS, Surface Plasmon and Adsorbate Vibrations Ao Teng 2010.10.11 Outline I. Electron Energy Loss Spectroscopy(EELS) and High Resolution EELS (HREELS) II. Surface Plasmon III. Adsorbate Vibrations Surface

More information

Photonic/Plasmonic Structures from Metallic Nanoparticles in a Glass Matrix

Photonic/Plasmonic Structures from Metallic Nanoparticles in a Glass Matrix Excerpt from the Proceedings of the COMSOL Conference 2008 Hannover Photonic/Plasmonic Structures from Metallic Nanoparticles in a Glass Matrix O.Kiriyenko,1, W.Hergert 1, S.Wackerow 1, M.Beleites 1 and

More information

SUPPORTING INFORMATION. Plasmon Spectroscopy and Chemical Structure of Small Bimetallic Cu (1-x) Ag x clusters.

SUPPORTING INFORMATION. Plasmon Spectroscopy and Chemical Structure of Small Bimetallic Cu (1-x) Ag x clusters. SUPPORTING INFORMATION Plasmon Spectroscopy and Chemical Structure of Small Bimetallic (1-x) x clusters. Michel Pellarin a*, Inas Issa a, Cyril Langlois b, Marie-Ange Lebeault a, Julien Ramade a, Jean

More information

Plan of the lectures

Plan of the lectures Plan of the lectures 1. Introductory remarks on metallic nanostructures Relevant quantities and typical physical parameters Applications. Linear electron response: Mie theory and generalizations 3. Nonlinear

More information

Fluorescent silver nanoparticles via exploding wire technique

Fluorescent silver nanoparticles via exploding wire technique PRAMANA c Indian Academy of Sciences Vol. 65, No. 5 journal of November 2005 physics pp. 815 819 Fluorescent silver nanoparticles via exploding wire technique ALQUDAMI ABDULLAH and S ANNAPOORNI Department

More information

Plasmonics. The long wavelength of light ( μm) creates a problem for extending optoelectronics into the nanometer regime.

Plasmonics. The long wavelength of light ( μm) creates a problem for extending optoelectronics into the nanometer regime. Plasmonics The long wavelength of light ( μm) creates a problem for extending optoelectronics into the nanometer regime. A possible way out is the conversion of light into plasmons. They have much shorter

More information

Supporting Information. Observation of Nanoscale Cooling Effects by Substrates and the Surrounding

Supporting Information. Observation of Nanoscale Cooling Effects by Substrates and the Surrounding Supporting Information Observation of Nanoscale Cooling Effects by Substrates and the Surrounding Media for Single Gold Nanoparticles under CW-laser Illumination Kenji Setoura, Yudai Okada, Daniel Werner,

More information

Solid State Physics Byungwoo Park Department of Materials Science and Engineering Seoul National University

Solid State Physics Byungwoo Park Department of Materials Science and Engineering Seoul National University Solid State Physics Byungwoo Park Department of Materials Science and Engineering Seoul National University http://bp.snu.ac.kr Types of Crystal Binding Kittel, Solid State Physics (Chap. 3) Solid State

More information

A Plasmonic Photocatalyst Consisting of Silver Nanoparticles Embedded in Titanium Dioxide. Ryan Huschka LANP Seminar February 19, 2008

A Plasmonic Photocatalyst Consisting of Silver Nanoparticles Embedded in Titanium Dioxide. Ryan Huschka LANP Seminar February 19, 2008 A Plasmonic Photocatalyst Consisting of Silver Nanoparticles Embedded in Titanium Dioxide Ryan Huschka LANP Seminar February 19, 2008 TiO 2 Applications White Pigment Photocatalyst Previous methods to

More information

Nanophysics: Main trends

Nanophysics: Main trends Nano-opto-electronics Nanophysics: Main trends Nanomechanics Main issues Light interaction with small structures Molecules Nanoparticles (semiconductor and metallic) Microparticles Photonic crystals Nanoplasmonics

More information

Boundary Element Method Calculations of LDOS and Decay Rates

Boundary Element Method Calculations of LDOS and Decay Rates Appendix A Boundary Element Method Calculations of LDOS and Decay Rates A.1 Decay Rates in Atomic Units This appendix provides a brief tutorial for BEM calculations of the total and radiative decay rates,

More information

Supplementary Information

Supplementary Information Electrochemical Charging of Single Gold Nanorods Carolina Novo, Alison M. Funston, Ann K. Gooding, Paul Mulvaney* School of Chemistry & Bio21 Institute, University of Melbourne, Parkville, VIC, 3010, Australia

More information

SUPPORTING INFORMATION. Influence of plasmonic Au nanoparticles on the photoactivity of

SUPPORTING INFORMATION. Influence of plasmonic Au nanoparticles on the photoactivity of SUPPORTING INFORMATION Influence of plasmonic Au nanoparticles on the photoactivity of Fe 2 O 3 electrodes for water splitting Elijah Thimsen, Florian Le Formal, Michael Grätzel and Scott C. Warren* Interband

More information

Effect of Temperature on Nanocomposite of Metal Nanoparticles in Photonic Crystals

Effect of Temperature on Nanocomposite of Metal Nanoparticles in Photonic Crystals Progress In Electromagnetics Research M, Vol. 41, 15 114, 215 Effect of Temperature on Nanocomposite of Metal Nanoparticles in Photonic Crystals Nambi R. Ramanujam 1, Kuladaisamy S. Joseph Wilson 2, *,andvasanrevathy

More information

Determination of size and concentration of gold and silica nanoparticles from absorption and turbidity spectra. Nikolai Khlebtsov

Determination of size and concentration of gold and silica nanoparticles from absorption and turbidity spectra. Nikolai Khlebtsov Determination of size and concentration of gold and silica nanoparticles from absorption and turbidity spectra Nikolai Khlebtsov Institute of Biochemistry and Physiology of Plants and Microorganisms (IBPPM),

More information

Chemical Reaction Engineering Prof. Jayant Modak Department of Chemical Engineering Indian Institute of Science, Bangalore

Chemical Reaction Engineering Prof. Jayant Modak Department of Chemical Engineering Indian Institute of Science, Bangalore Chemical Reaction Engineering Prof. Jayant Modak Department of Chemical Engineering Indian Institute of Science, Bangalore Lecture No. # 26 Problem solving : Heterogeneous reactions Friends, in last few

More information

Supplementary Figure S1 SEM and optical images of Si 0.6 H 0.4 colloids. a, SEM image of Si 0.6 H 0.4 colloids. b, The size distribution of Si 0.

Supplementary Figure S1 SEM and optical images of Si 0.6 H 0.4 colloids. a, SEM image of Si 0.6 H 0.4 colloids. b, The size distribution of Si 0. Supplementary Figure S1 SEM and optical images of Si 0.6 H 0.4 colloids. a, SEM image of Si 0.6 H 0.4 colloids. b, The size distribution of Si 0.6 H 0.4 colloids. The standard derivation is 4.4 %. Supplementary

More information

The mathematics of scattering and absorption and emission

The mathematics of scattering and absorption and emission The mathematics of scattering and absorption and emission The transmittance of an layer depends on its optical depth, which in turn depends on how much of the substance the radiation has to pass through,

More information

Lecture 10 Light-Matter Interaction Part 4 Surface Polaritons 2. EECS Winter 2006 Nanophotonics and Nano-scale Fabrication P.C.

Lecture 10 Light-Matter Interaction Part 4 Surface Polaritons 2. EECS Winter 2006 Nanophotonics and Nano-scale Fabrication P.C. Lecture 10 Light-Matter Interaction Part 4 Surface Polaritons 2 EECS 598-002 Winter 2006 Nanophotonics and Nano-scale Fabrication P.C.Ku Schedule for the rest of the semester Introduction to light-matter

More information

Collective effects in second-harmonic generation from plasmonic oligomers

Collective effects in second-harmonic generation from plasmonic oligomers Supporting Information Collective effects in second-harmonic generation from plasmonic oligomers Godofredo Bautista,, *, Christoph Dreser,,, Xiaorun Zang, Dieter P. Kern,, Martti Kauranen, and Monika Fleischer,,*

More information

Scattering cross-section (µm 2 )

Scattering cross-section (µm 2 ) Supplementary Figures Scattering cross-section (µm 2 ).16.14.12.1.8.6.4.2 Total scattering Electric dipole, a E (1,1) Magnetic dipole, a M (1,1) Magnetic quardupole, a M (2,1). 44 48 52 56 Wavelength (nm)

More information

Influence of dielectric core, embedding medium and size on the optical properties of gold nanoshells

Influence of dielectric core, embedding medium and size on the optical properties of gold nanoshells Solid State Communications 146 (008) 7 11 www.elsevier.com/locate/ssc Influence of dielectric core, embedding medium and size on the optical properties of gold nanoshells DaJian Wu a,b, XiaoDong Xu a,

More information

Rapid method to estimate the concentration of citrate capped silver nanoparticles from UV-visible light spectra

Rapid method to estimate the concentration of citrate capped silver nanoparticles from UV-visible light spectra Electronic Supplementary Material (ESI) for Analyst. This journal is The Royal Society of Chemistry 2014 Supplementary Information Rapid method to estimate the concentration of citrate capped silver nanoparticles

More information

Name: (a) What core levels are responsible for the three photoelectron peaks in Fig. 1?

Name: (a) What core levels are responsible for the three photoelectron peaks in Fig. 1? Physics 243A--Surface Physics of Materials: Spectroscopy Final Examination December 16, 2014 (3 problems, 100 points total, open book, open notes and handouts) Name: [1] (50 points), including Figures

More information

Chapter 2 Surface Plasmon Resonance

Chapter 2 Surface Plasmon Resonance Chapter 2 Surface Plasmon Resonance 2.1 Introduction Free electrons in metals behave like a gas of free charge carriers (also known as a plasma). The quanta corresponding to plasma oscillations are called

More information

arxiv:astro-ph/ v1 13 Nov 2003

arxiv:astro-ph/ v1 13 Nov 2003 Discrete-dipole approximation with polarizabilities that account for both finite wavelength and target geometry Matthew J. Collinge and B. T. Draine Princeton University Observatory, Princeton, New Jersey

More information

Size dependence of multipolar plasmon resonance frequencies and damping rates in simple metal spherical nanoparticles

Size dependence of multipolar plasmon resonance frequencies and damping rates in simple metal spherical nanoparticles The original publication is available at www.eurphysj.org: http://www.epjst-journal.org/index.php?option=article&access=standard&itemid=9&url= /articles/epjst/pdf/7/5/st44.pdf EPJ manuscript No. (will

More information

Supporting Information: Resonant non-plasmonic nanoparticles for. efficient temperature-feedback optical heating

Supporting Information: Resonant non-plasmonic nanoparticles for. efficient temperature-feedback optical heating Supporting Information: Resonant non-plasmonic nanoparticles for efficient temperature-feedback optical heating George P. Zograf, Mihail I. Petrov,,, Dmitry A. Zuev, Pavel A. Dmitriev, Valentin A. Milichko,

More information

Chapter 2 Optical Properties of Nanocomposites Containing Metal Nanoparticles

Chapter 2 Optical Properties of Nanocomposites Containing Metal Nanoparticles Chapter 2 Optical Properties of Nanocomposites Containing Metal Nanoparticles Interaction of light with nanocomposites reveals novel optical phenomena indicating unrivalled optical properties of these

More information

Simulation of Surface Plasmon Resonance on Different Size of a Single Gold Nanoparticle

Simulation of Surface Plasmon Resonance on Different Size of a Single Gold Nanoparticle Journal of Physics: Conference Series PAPER OPEN ACCESS Simulation of Surface Plasmon Resonance on Different Size of a Single Gold Nanoparticle To cite this article: Norsyahidah Md Saleh and A. Abdul Aziz

More information

NanoLab (Phys4970) Mie Theory & Extinction Spectra [ver 1.1.0]

NanoLab (Phys4970) Mie Theory & Extinction Spectra [ver 1.1.0] Part B) Model your results in MiePlot. Step 0) Download Mieplot from the NanoLab www site. Install this on your computer. It is a small program and should not present any difficulty. Step 1) Start MiePlot

More information

Dispersion Information for Photonic Fiber Modes from CUDOS Simulations

Dispersion Information for Photonic Fiber Modes from CUDOS Simulations July 14, 005 ARDB Note Dispersion Information for Photonic Fiber Modes from CUDOS Simulations Robert J. Noble Stanford Linear Accelerator Center, Stanford University 575 Sand Hill Road, Menlo Park, California

More information

Absorption and scattering

Absorption and scattering Absorption and scattering When a beam of radiation goes through the atmosphere, it encounters gas molecules, aerosols, cloud droplets, and ice crystals. These objects perturb the radiation field. Part

More information

STUDIES ON ZnS - CuS NANOPARTICLE SYSTEM.

STUDIES ON ZnS - CuS NANOPARTICLE SYSTEM. CHAPTER - VI STUDIES ON ZnS - CuS NANOPARTICLE SYSTEM. 6.1 INTRODUCTION ZnS is an important direct band gap semiconductor. It has a band gap energy of 3.6 ev[1], displays a high refractive index (2.37)

More information

Unusual Molecular Material formed through Irreversible Transformation and Revealed by 4D Electron Microscopy

Unusual Molecular Material formed through Irreversible Transformation and Revealed by 4D Electron Microscopy 26 March 2013 Unusual Molecular Material formed through Irreversible Transformation and Revealed by 4D Electron Microscopy Renske M. van der Veen, Antoine Tissot, Andreas Hauser, Ahmed H. Zewail Physical

More information

Supporting Information. Optical Scattering Spectral Thermometry and Refractometry of a Single Gold Nanoparticle under CW laser excitation

Supporting Information. Optical Scattering Spectral Thermometry and Refractometry of a Single Gold Nanoparticle under CW laser excitation Supporting Information Optical Scattering Spectral Thermometry and Refractometry of a Single Gold Nanoparticle under CW laser excitation Kenji Setoura, Daniel Werner, and Shuichi Hashimoto* Department

More information

Special Properties of Au Nanoparticles

Special Properties of Au Nanoparticles Special Properties of Au Nanoparticles Maryam Ebrahimi Chem 7500/750 March 28 th, 2007 1 Outline Introduction The importance of unexpected electronic, geometric, and chemical properties of nanoparticles

More information

Nanoscale optical circuits: controlling light using localized surface plasmon resonances

Nanoscale optical circuits: controlling light using localized surface plasmon resonances Nanoscale optical circuits: controlling light using localized surface plasmon resonances T. J. Davis, D. E. Gómez and K. C. Vernon CSIRO Materials Science and Engineering Localized surface plasmon (LSP)

More information

Langmuir-Schaefer deposition of quantum dot multilayers. Supporting Information

Langmuir-Schaefer deposition of quantum dot multilayers. Supporting Information Langmuir-Schaefer deposition of quantum dot multilayers Supporting Information I. AFM, UV-VIS and TEM characterization of LS layers S1 Low-magnification TEM images of Q-CdSe layers, deposited on a carbon-coated

More information

SCATTERING OF ELECTROMAGNETIC WAVES ON METAL NANOPARTICLES. Tomáš Váry, Juraj Chlpík, Peter Markoš

SCATTERING OF ELECTROMAGNETIC WAVES ON METAL NANOPARTICLES. Tomáš Váry, Juraj Chlpík, Peter Markoš SCATTERING OF ELECTROMAGNETIC WAVES ON METAL NANOPARTICLES Tomáš Váry, Juraj Chlpík, Peter Markoš ÚJFI, FEI STU, Bratislava E-mail: tomas.vary@stuba.sk Received xx April 2012; accepted xx May 2012. 1.

More information

Plasmonic Photovoltaics Harry A. Atwater California Institute of Technology

Plasmonic Photovoltaics Harry A. Atwater California Institute of Technology Plasmonic Photovoltaics Harry A. Atwater California Institute of Technology Surface plasmon polaritons and localized surface plasmons Plasmon propagation and absorption at metal-semiconductor interfaces

More information

arxiv:physics/ v1 [physics.optics] 26 May 2005

arxiv:physics/ v1 [physics.optics] 26 May 2005 LETTER TO THE EDITOR arxiv:physics/55186v1 [physics.optics] 26 May 25 Divergence of Dipole Sums and the Nature of Non-Lorentzian Exponentially Narrow Resonances in One-Dimensional Periodic Arrays of Nanospheres

More information

Visualizing the bi-directional electron transfer in a Schottky junction consisted of single CdS nanoparticles and a planar gold film

Visualizing the bi-directional electron transfer in a Schottky junction consisted of single CdS nanoparticles and a planar gold film Electronic Supplementary Material (ESI) for Chemical Science. This journal is The Royal Society of Chemistry 2017 Electronic Supplementary Information Visualizing the bi-directional electron transfer in

More information

Study of Surface Plasmon Excitation on Different Structures of Gold and Silver

Study of Surface Plasmon Excitation on Different Structures of Gold and Silver Nanoscience and Nanotechnology 2015, 5(4): 71-81 DOI: 10.5923/j.nn.20150504.01 Study of Surface Plasmon Excitation on Different Structures of Gold and Silver Anchu Ashok 1,*, Arya Arackal 1, George Jacob

More information

Nonlocal effects on optical and molecular interactions with metallic nanoshells

Nonlocal effects on optical and molecular interactions with metallic nanoshells PHYSICAL REVIEW B 73, 125438 2006 Nonlocal effects on optical and molecular interactions with metallic nanoshells Railing Chang 1 and P. T. Leung 2 1 Institute of Optoelectronic Sciences, National Taiwan

More information

Energy transport in metal nanoparticle plasmon waveguides

Energy transport in metal nanoparticle plasmon waveguides Energy transport in metal nanoparticle plasmon waveguides Stefan A. Maier, Pieter G. Kik, and Harry A. Atwater California Institute of Technology Thomas J. Watson Laboratory of Applied Physics, Pasadena,

More information

Nano Optics Based on Coupled Metal Nanoparticles

Nano Optics Based on Coupled Metal Nanoparticles Nano Optics Based on Coupled Metal Nanoparticles Shangjr Gwo ( 果尚志 ) Department of Physics National Tsing-Hua University, Hsinchu 30013, Taiwan E-mail: gwo@phys.nthu.edu.tw NDHU-Phys (2010/03/01) Background

More information

Supporting Information for. Shape Transformation of Gold Nanoplates and their Surface Plasmon. Characterization: Triangular to Hexagonal Nanoplates

Supporting Information for. Shape Transformation of Gold Nanoplates and their Surface Plasmon. Characterization: Triangular to Hexagonal Nanoplates 1 Supporting Information for Shape Transformation of Gold Nanoplates and their Surface Plasmon Characterization: Triangular to Hexagonal Nanoplates Soonchang Hong, Kevin L. Shuford *,, and Sungho Park

More information

Metamaterials & Plasmonics

Metamaterials & Plasmonics Metamaterials & Plasmonics Exploring the Impact of Rotating Rectangular Plasmonic Nano-hole Arrays on the Transmission Spectra and its Application as a Plasmonic Sensor. Abstract Plasmonic nano-structures

More information

Longitudinal quantum plasmons in copper, gold, and silver

Longitudinal quantum plasmons in copper, gold, and silver Longitudinal quantum plasmons in copper, gold, and silver M. Moaied, 1,,3 *, S. Palomba 1, and K. Ostrikov,3,4 1 Institute of Photonics and Optical Science (IPOS), School of Physics, The University of

More information

ECE280: Nano-Plasmonics and Its Applications. Week8

ECE280: Nano-Plasmonics and Its Applications. Week8 ECE280: Nano-Plasmonics and Its Applications Week8 Surface Enhanced Raman Scattering (SERS) and Surface Plasmon Amplification by Stimulated Emission of Radiation (SPASER) Raman Scattering Chandrasekhara

More information

Supplementary Figure 1. Extinction spectra of rhodium nanocubes. UV-vis spectra of the Rh nanocubes in ethanol solution (black) and on a porous Al2O3

Supplementary Figure 1. Extinction spectra of rhodium nanocubes. UV-vis spectra of the Rh nanocubes in ethanol solution (black) and on a porous Al2O3 Supplementary Figure 1. Extinction spectra of rhodium nanocubes. UV-vis spectra of the Rh nanocubes in ethanol solution (black) and on a porous Al2O3 support (blue). The Rh nanocubes in ethanol solution

More information

Investigating functionalized active coated nanoparticles for use in nano-sensing applications

Investigating functionalized active coated nanoparticles for use in nano-sensing applications Investigating functionalized active coated nanoparticles for use in nano-sensing applications Joshua A. Gordon 1*, Richard W. Ziolkowski 2, 1 1 College of Optical Sciences, University of Arizona, Tucson,

More information

Plasmonics: elementary excitation of a plasma (gas of free charges) nano-scale optics done with plasmons at metal interfaces

Plasmonics: elementary excitation of a plasma (gas of free charges) nano-scale optics done with plasmons at metal interfaces Plasmonics Plasmon: Plasmonics: elementary excitation of a plasma (gas of free charges) nano-scale optics done with plasmons at metal interfaces Femius Koenderink Center for Nanophotonics AMOLF, Amsterdam

More information

An Introduction to Hyperfine Structure and Its G-factor

An Introduction to Hyperfine Structure and Its G-factor An Introduction to Hyperfine Structure and Its G-factor Xiqiao Wang East Tennessee State University April 25, 2012 1 1. Introduction In a book chapter entitled Model Calculations of Radiation Induced Damage

More information

Supplementary Information for Semiconductor Solar Superabsorbers

Supplementary Information for Semiconductor Solar Superabsorbers Supplementary Information for Semiconductor Solar Superabsorbers Yiling Yu, Lujun Huang, Linyou Cao, * Department of Materials Science and Engineering, North Carolina State University, Raleigh NC 7695;

More information

Blueshift of the silver plasmon band using controlled nanoparticle dissolution in aqueous solution

Blueshift of the silver plasmon band using controlled nanoparticle dissolution in aqueous solution Downloaded from orbit.dtu.dk on: Oct 23, 2018 Blueshift of the silver plasmon band using controlled nanoparticle dissolution in aqueous solution Mogensen, Klaus Bo; Kneipp, Katrin Published in: Proceedings

More information

Optical properties of morphology-controlled gold nanoparticles

Optical properties of morphology-controlled gold nanoparticles Optical properties of morphology-controlled gold nanoparticles Qiguang Yang, 1* Jaetae Seo, 1* Wan-Joong Kim, SungSoo Jung, 3 Bagher Tabibi, 1 Justin Vazquez, 1 Jasmine Austin, 1 and Doyle Temple 1 1 Department

More information

Appendix A Detector Calibration

Appendix A Detector Calibration Appix A Detector Calibration The scattering pattern from single clusters analyzed in Sect. 3.5 have been obtained with a large area detector which allows for spatially resolved measurement of the scattered

More information

often display a deep green color due to where the SPR occurs (i.e., the wavelength of light that interacts with this specific morphology).

often display a deep green color due to where the SPR occurs (i.e., the wavelength of light that interacts with this specific morphology). Synthesis-Dependent Catalytic Properties of Gold Nanoparticles Nanoscience is the study of materials that have dimensions, intuitively, on the nanoscale, typically between 1 100 nm. This field has received

More information

2016 Lloyd G. Elliott University Prize Exam Compiled by the Department of Physics & Astronomy, University of Waterloo

2016 Lloyd G. Elliott University Prize Exam Compiled by the Department of Physics & Astronomy, University of Waterloo Canadian Association of Physicists SUPPORTING PHYSICS RESEARCH AND EDUCATION IN CANADA 2016 Lloyd G. Elliott University Prize Exam Compiled by the Department of Physics & Astronomy, University of Waterloo

More information

Geometries and materials for subwavelength surface plasmon modes

Geometries and materials for subwavelength surface plasmon modes Geometries and materials for subwavelength surface plasmon modes Plasmon slot waveguides : Metal-Insulator-Metal (MIM) Metal nanorods and nanotips Metal nanoparticles Metal Dielectric Dielectric Metal

More information

The optical properties of the cobalt nanoparticles in the transparent condensed matrices

The optical properties of the cobalt nanoparticles in the transparent condensed matrices NANOSYSTEMS: PHYSICS, CHEMISTRY, MATHEMATICS, 2015, 6 (5), P. 628 636 The optical properties of the cobalt nanoparticles in the transparent condensed matrices M. V. Ananyeva 1, A. V. Kalenskii 1, A. A.

More information

Plasmonics: elementary excitation of a plasma (gas of free charges) nano-scale optics done with plasmons at metal interfaces

Plasmonics: elementary excitation of a plasma (gas of free charges) nano-scale optics done with plasmons at metal interfaces Plasmonics Plasmon: Plasmonics: elementary excitation of a plasma (gas of free charges) nano-scale optics done with plasmons at metal interfaces Femius Koenderink Center for Nanophotonics AMOLF, Amsterdam

More information

Modified Maxwell-Garnett equation for the effective transport coefficients in inhomogeneous media

Modified Maxwell-Garnett equation for the effective transport coefficients in inhomogeneous media J. Phys. A: Math. Gen. 3 (998) 7227 7234. Printed in the UK PII: S0305-4470(98)93976-2 Modified Maxwell-Garnett equation for the effective transport coefficients in inhomogeneous media Juris Robert Kalnin

More information

Evaluating nanogaps in Ag and Au nanoparticle clusters for SERS applications using COMSOL Multiphysics

Evaluating nanogaps in Ag and Au nanoparticle clusters for SERS applications using COMSOL Multiphysics Evaluating nanogaps in Ag and Au nanoparticle clusters for SERS applications using COMSOL Multiphysics Ramesh Asapu 1, Radu-George Ciocarlan 2, Nathalie Claes 3, Natan Blommaerts 1, Sara Bals 3, Pegie

More information

MANIPAL INSTITUTE OF TECHNOLOGY

MANIPAL INSTITUTE OF TECHNOLOGY SCHEME OF EVAUATION MANIPA INSTITUTE OF TECHNOOGY MANIPA UNIVERSITY, MANIPA SECOND SEMESTER B.Tech. END-SEMESTER EXAMINATION - MAY SUBJECT: ENGINEERING PHYSICS (PHY/) Time: 3 Hrs. Max. Marks: 5 Note: Answer

More information

Preface to the Second Edition. Preface to the First Edition

Preface to the Second Edition. Preface to the First Edition Contents Preface to the Second Edition Preface to the First Edition iii v 1 Introduction 1 1.1 Relevance for Climate and Weather........... 1 1.1.1 Solar Radiation.................. 2 1.1.2 Thermal Infrared

More information

Supplementary Figure 1 Reflection and transmission measurement. Supplementary Figure 2 Wavelength dependence of χ

Supplementary Figure 1 Reflection and transmission measurement. Supplementary Figure 2 Wavelength dependence of χ Supplementary Figure 1 Reflection and transmission measurement. (a) and (b) show the reflection and transmission curves with 45 incident angle and S-polarization for the 3 nm metal quantum well sample.

More information

Appendix 1: List of symbols

Appendix 1: List of symbols Appendix 1: List of symbols Symbol Description MKS Units a Acceleration m/s 2 a 0 Bohr radius m A Area m 2 A* Richardson constant m/s A C Collector area m 2 A E Emitter area m 2 b Bimolecular recombination

More information

Nanoscale Systems for Opto-Electronics

Nanoscale Systems for Opto-Electronics Nanoscale Systems for Opto-Electronics 675 PL intensity [arb. units] 700 Wavelength [nm] 650 625 600 5µm 1.80 1.85 1.90 1.95 Energy [ev] 2.00 2.05 Nanoscale Systems for Opto-Electronics Lecture 1 Dozent:

More information

Optical Characteristics of ZnO Based Photodetectors Doped with Au Nanoparticles

Optical Characteristics of ZnO Based Photodetectors Doped with Au Nanoparticles nd International Conference on Mechanical and Electronics Engineering (ICMEE ) Optical Characteristics of ZnO Based Photodetectors Doped with Au Nanoparticles S. Mohammadnejad, S. G. Samani, and E. Rahimi

More information

Re-evaluating CeO 2 Expansion Upon Reduction: Non-counterpoised Forces, Not Ionic Radius Effects, are the Cause

Re-evaluating CeO 2 Expansion Upon Reduction: Non-counterpoised Forces, Not Ionic Radius Effects, are the Cause Re-evaluating CeO 2 Expansion Upon Reduction: Non-counterpoised Forces, Not Ionic Radius Effects, are the Cause Christopher L. Muhich, a* a ETH Zurich, Department of Mechanical and Process Engineering,

More information

X-ray Diffraction. Diffraction. X-ray Generation. X-ray Generation. X-ray Generation. X-ray Spectrum from Tube

X-ray Diffraction. Diffraction. X-ray Generation. X-ray Generation. X-ray Generation. X-ray Spectrum from Tube X-ray Diffraction Mineral identification Mode analysis Structure Studies X-ray Generation X-ray tube (sealed) Pure metal target (Cu) Electrons remover inner-shell electrons from target. Other electrons

More information

Taking cascaded plasmonic field enhancement to the ultimate limit in silver nanoparticle dimers S. Toroghi* a, P. G. Kik a,b

Taking cascaded plasmonic field enhancement to the ultimate limit in silver nanoparticle dimers S. Toroghi* a, P. G. Kik a,b Taking cascaded plasmonic field enhancement to the ultimate limit in silver nanoparticle dimers S. Toroghi* a, P. G. Kik a,b a CREOL, The College of Optics and Photonics, University of Central Florida,

More information

Supplementary Figure 1 Simulations of the lm thickness dependence of plasmon modes on lms or disks on a 30 nm thick Si 3 N 4 substrate.

Supplementary Figure 1 Simulations of the lm thickness dependence of plasmon modes on lms or disks on a 30 nm thick Si 3 N 4 substrate. Supplementary Figure 1 Simulations of the lm thickness dependence of plasmon modes on lms or disks on a 30 nm thick Si 3 N 4 substrate. (a) Simulated plasmon energy at k=30 µm 1 for the surface plasmon

More information

Supplementary Information: Linear dependence of surface expansion speed on initial plasma temperature in warm dense matter

Supplementary Information: Linear dependence of surface expansion speed on initial plasma temperature in warm dense matter Supplementary Information: Linear dependence of surface expansion speed on initial plasma temperature in warm dense matter W. Bang, 1 B. J. Albright, 1 P. A. Bradley, 1 E. L. Vold, 1 J. C. Boettger, 1

More information

Ch 7 Quantum Theory of the Atom (light and atomic structure)

Ch 7 Quantum Theory of the Atom (light and atomic structure) Ch 7 Quantum Theory of the Atom (light and atomic structure) Electromagnetic Radiation - Electromagnetic radiation consists of oscillations in electric and magnetic fields. The oscillations can be described

More information

COX & GIULI'S PRINCIPLES OF STELLAR STRUCTURE

COX & GIULI'S PRINCIPLES OF STELLAR STRUCTURE COX & GIULI'S PRINCIPLES OF STELLAR STRUCTURE Extended Second Edition A. Weiss, W. Hillebrandt, H.-C. Thomas and H. Ritter Max-Planck-lnstitut fur Astrophysik, Garching, Germany C S P CONTENTS PREFACE

More information