Merge lp:~albertog/siesta/4.1-wfs into lp:siesta/4.1

Proposed by Alberto Garcia
Status: Merged
Approved by: Nick Papior
Approved revision: 1117
Merged at revision: 1090
Proposed branch: lp:~albertog/siesta/4.1-wfs
Merge into: lp:siesta/4.1
Diff against target: 40851 lines (+32943/-4438)
99 files modified
Docs/Contributors.txt (+1/-0)
Docs/siesta.tex (+1/-0)
Src/Makefile (+5/-5)
Src/bands.F (+41/-59)
Src/diag2g.F (+18/-5)
Src/diag2k.F (+66/-24)
Src/diag3g.F (+21/-6)
Src/diag3k.F (+61/-21)
Src/diagg.F (+8/-6)
Src/diagk.F (+5/-1)
Src/diagon.F (+3/-3)
Src/ioeig.f (+11/-5)
Src/m_spin.F90 (+2/-0)
Src/print_spin.F90 (+64/-49)
Src/siesta_analysis.F (+100/-70)
Src/writewave.F (+116/-79)
Tests/Pseudos/Bi.psf (+3061/-0)
Tests/Pseudos/Se.psf (+2891/-0)
Tests/Reference/bi2se3_3ql.out (+889/-0)
Tests/bi2se3_3ql/bi2se3_3ql.fdf (+158/-0)
Tests/bi2se3_3ql/bi2se3_3ql.pseudos (+1/-0)
Tests/bi2se3_3ql/makefile (+6/-0)
Util/COOP/Docs/UnitsAndMeaningOfCurves.txt (+55/-33)
Util/COOP/Makefile (+19/-5)
Util/COOP/README (+40/-0)
Util/COOP/Tests/bi2se3_3ql/README (+24/-0)
Util/COOP/Tests/bi2se3_3ql/spin_texture.dat.reference (+14150/-0)
Util/COOP/Tests/ge_fatbands_so/README (+55/-0)
Util/COOP/Tests/ge_fatbands_so/coo.gplot (+3/-0)
Util/COOP/Tests/ge_fatbands_so/coo.mpr (+10/-0)
Util/COOP/Tests/ge_fatbands_so/fatbands.mpr (+22/-0)
Util/COOP/Tests/ge_fatbands_so/pdos.gplot (+3/-0)
Util/COOP/Tests/ge_fatbands_so/pdos.mpr (+8/-0)
Util/COOP/dm_creator.F90 (+77/-145)
Util/COOP/fat.f90 (+46/-20)
Util/COOP/io_hs.f90 (+2/-0)
Util/COOP/main_vars.f90 (+4/-2)
Util/COOP/mprop.f90 (+179/-107)
Util/COOP/read_spin_texture.f90 (+103/-0)
Util/COOP/spin_texture.f90 (+419/-0)
Util/COOP/subs.f90 (+66/-5)
Util/Denchar/Docs/README (+0/-3)
Util/Denchar/Docs/denchar.tex (+16/-32)
Util/Denchar/Src/Makefile (+11/-12)
Util/Denchar/Src/README (+27/-1)
Util/Denchar/Src/denchar.f (+90/-133)
Util/Denchar/Src/itochar.f (+0/-54)
Util/Denchar/Src/local_reinit.f (+6/-10)
Util/Denchar/Src/readsts.f (+0/-174)
Util/Denchar/Src/readwaves.f (+0/-163)
Util/Denchar/Src/rhoofr.f (+134/-155)
Util/Denchar/Src/stsofr.f (+0/-371)
Util/Denchar/Src/wavofr.f (+452/-495)
Util/Denchar/Src/wrout.f (+1/-30)
Util/Eig2DOS/Eig2DOS.f90 (+37/-18)
Util/Grid/README (+3/-1)
Util/Grid/g2c_ng.f (+13/-4)
Util/Grid/m_gridfunc.F90 (+248/-10)
Util/Grid/makefile (+8/-1)
Util/Grid/v_info.f90 (+36/-0)
Util/README (+5/-5)
Util/STM/README.md (+80/-0)
Util/STM/ol-stm/Docs/stm.tex (+165/-157)
Util/STM/ol-stm/Examples/2d.gplot (+17/-0)
Util/STM/ol-stm/Examples/Benzene/C.psf (+1525/-0)
Util/STM/ol-stm/Examples/Benzene/H.psf (+1527/-0)
Util/STM/ol-stm/Examples/Benzene/benzene-stm.STRUCT_IN (+16/-0)
Util/STM/ol-stm/Examples/Benzene/benzene-stm.fdf (+54/-0)
Util/STM/ol-stm/Examples/ML-Cr/AGCR.fdf (+111/-0)
Util/STM/ol-stm/Examples/ML-Cr/Cr.psf (+2821/-0)
Util/STM/ol-stm/Examples/ML-Cr/README (+7/-0)
Util/STM/ol-stm/Examples/ML-Cr/q.inp (+6/-0)
Util/STM/ol-stm/Examples/README (+10/-9)
Util/STM/ol-stm/Examples/siesta.fdf (+0/-81)
Util/STM/ol-stm/Examples/stm.fdf (+0/-32)
Util/STM/ol-stm/Src/Makefile (+29/-17)
Util/STM/ol-stm/Src/README (+27/-0)
Util/STM/ol-stm/Src/atompla.f (+0/-122)
Util/STM/ol-stm/Src/extrapolate.f (+32/-85)
Util/STM/ol-stm/Src/length.f (+0/-21)
Util/STM/ol-stm/Src/m_wfsx.f (+0/-159)
Util/STM/ol-stm/Src/mainstm.F (+116/-152)
Util/STM/ol-stm/Src/matvect.f (+0/-27)
Util/STM/ol-stm/Src/readstm.f (+20/-24)
Util/STM/ol-stm/Src/redata.f (+3/-4)
Util/STM/ol-stm/Src/stm.f (+388/-463)
Util/STM/ol-stm/Src/sts.f (+582/-0)
Util/STM/ol-stm/Src/vacpot.f (+55/-110)
Util/STM/simple-stm/Makefile (+15/-14)
Util/STM/simple-stm/README.NXNY (+24/-0)
Util/STM/simple-stm/options.f90 (+201/-0)
Util/STM/simple-stm/plstm.f90 (+547/-401)
Util/STM/simple-stm/plsts.f (+126/-0)
Util/WFS/README (+18/-0)
Util/WFS/info_wfsx.f (+0/-81)
Util/WFS/m_getopts.f90 (+202/-0)
Util/WFS/makefile (+7/-2)
Util/WFS/readwfx.f90 (+310/-154)
version.info (+1/-1)
To merge this branch: bzr merge lp:~albertog/siesta/4.1-wfs
Reviewer Review Type Date Requested Status
Nick Papior Approve
Review via email: mp+369095@code.launchpad.net

Commit message

Update of tools for NC/SOC wave-function-related analysis

* NC and SOC diagonalizations can now write wavefunctions (spinors) to a .WFSX
  file. (Bands, COOP, selected k-points. See manual)

* Analysis:

 — COOP/mprop, COOP/fat(bands): They can now process spinors. There is
 currently no extra filtering by spin component.

 — COOP/spin_texture.f90: New program to generate spin-texture from
 wavefunctions, after code from Roberto Robles.

 — Denchar: The program is now aware of NC/SOC wavefunctions. It works
            in streaming mode, and individual wfs can be selected.
            See Util/Denchar/Src/README for some caveats and further
            ideas. STS functionality moved to the STM directory.

 — STM: Major restructuring. See Util/STM/README.md

  — The plstm program has many more features and is the main
  post-processor for STM info. Type ‘plstm -h'

  — The 'stm' program in STM/ol-stm (also known as ‘wfs2ldos’) can
    work in both “normal” and “projection” mode. It now generates a
    single ‘Siesta grid-style file’ that can be later processed by
    ‘plstm’. It can currently generate STS information on a complete
    plane, and even on a set of planes.

It is expected that the tools will be refined and extended in the
near future, as more experience is gained.

Caveats:

  The 'diagk_file' and diagkp routines cannot write wavefunctions in the WFSX format.

To post a comment you must log in.
lp:~albertog/siesta/4.1-wfs updated
1116. By Nick Papior

Used tSpin constructs in bands/writewave

Using tSpin cleans up a bit some of the 'magic' variables used in
several places.

Also, a clean up of print_spin has removed duplicate work for SO
calculations.

(Thanks to Nick Papior)

1117. By Alberto Garcia

Sync to 4.1 rev 1089

Revision history for this message
Nick Papior (nickpapior) wrote :

Approved, will merge!

review: Approve

Preview Diff

[H/L] Next/Prev Comment, [J/K] Next/Prev File, [N/P] Next/Prev Hunk
1=== modified file 'Docs/Contributors.txt'
2--- Docs/Contributors.txt 2018-10-22 14:12:27 +0000
3+++ Docs/Contributors.txt 2019-08-15 23:47:25 +0000
4@@ -60,6 +60,7 @@
5 Magnus Paulsson
6 Oscar Paz
7 Andrei Postnikov
8+Roberto Robles
9 Tristana Sondon
10 Andrew Walker
11 Andrew Walkingshaw
12
13=== modified file 'Docs/siesta.tex'
14--- Docs/siesta.tex 2019-08-08 10:08:23 +0000
15+++ Docs/siesta.tex 2019-08-15 23:47:25 +0000
16@@ -277,6 +277,7 @@
17 Magnus Paulsson,
18 Oscar Paz,
19 Andrei Postnikov,
20+Roberto Robles,
21 Tristana Sondon,
22 Andrew Walker,
23 Andrew Walkingshaw,
24
25=== modified file 'Src/Makefile'
26--- Src/Makefile 2019-08-08 07:27:12 +0000
27+++ Src/Makefile 2019-08-15 23:47:25 +0000
28@@ -685,11 +685,11 @@
29 dhscf.o: vmat.o
30 diag.o: alloc.o diag_option.o parallel.o precision.o sys.o
31 diag2g.o: fermid.o intrinsic_missing.o parallel.o parallelsubs.o precision.o
32-diag2g.o: sys.o
33-diag2k.o: fermid.o parallel.o parallelsubs.o precision.o sys.o
34+diag2g.o: sys.o writewave.o
35+diag2k.o: fermid.o parallel.o parallelsubs.o precision.o sys.o writewave.o
36 diag3g.o: fermid.o intrinsic_missing.o parallel.o parallelsubs.o precision.o
37-diag3g.o: sys.o
38-diag3k.o: fermid.o parallel.o parallelsubs.o precision.o sys.o
39+diag3g.o: sys.o writewave.o
40+diag3k.o: fermid.o parallel.o parallelsubs.o precision.o sys.o writewave.o
41 diag_option.o: parallel.o precision.o
42 diagg.o: alloc.o fermid.o intrinsic_missing.o m_spin.o parallel.o
43 diagg.o: parallelsubs.o precision.o sys.o writewave.o
44@@ -1352,7 +1352,7 @@
45 write_subs.o: m_steps.o m_stress.o m_ts_global_vars.o parallel.o precision.o
46 write_subs.o: siesta_cml.o siesta_geom.o siesta_options.o units.o zmatrix.o
47 writewave.o: alloc.o atmfuncs.o atomlist.o densematrix.o diag.o diag_option.o
48-writewave.o: get_kpoints_scale.o kpoint_grid.o m_spin.o parallel.o
49+writewave.o: get_kpoints_scale.o kpoint_grid.o m_spin.o m_spin.o parallel.o
50 writewave.o: parallelsubs.o precision.o siesta_geom.o sys.o units.o
51 xml.o: precision.o
52 zm_broyden_optim.o: m_broyddj_nocomm.o parallel.o precision.o sys.o units.o
53
54=== modified file 'Src/bands.F'
55--- Src/bands.F 2018-10-17 13:04:40 +0000
56+++ Src/bands.F 2019-08-15 23:47:25 +0000
57@@ -296,7 +296,8 @@
58 end subroutine initbands
59
60
61- subroutine bands( no_s, nspin, maxspn, no_u, no_l, maxnh, maxk,
62+ subroutine bands( no_s, spin,
63+ . no_u, no_l,maxnh, maxk,
64 . numh, listhptr, listh, H, S, ef, xij, indxuo,
65 . writeb, nk, kpoint, ek, occtol, getPSI )
66
67@@ -305,40 +306,39 @@
68 C Written by J.Soler, August 1997 and August 1998.
69 C Initialisation moved into a separate routine, JDG Jan 2000.
70 C WFS options by A. Garcia, April 2012
71+C Cleaned for tSpin by N. Papior, August 2019
72
73 C **************************** INPUT **********************************
74 C integer no_s : Number of basis orbitals in supercell
75-C integer nspin : Number of spin components
76-C integer maxspn : Maximum number of spin components
77-C nspin /= maxspn for spin-orbit
78+C type(tSpin) spin : Containing all spin-information
79 C integer maxnh : Maximum number of orbitals interacting
80 C with any orbital
81 C integer maxk : Last dimension of kpoint and ek
82-C integer numh(no_l) : Number of nonzero elements of each row
83+C integer numh(no_l) : Number of nonzero elements of each row
84 C of hamiltonian matrix
85-C integer listhptr(no_l) : Pointer to start of each row of the
86+C integer listhptr(no_l) : Pointer to start of each row of the
87 C hamiltonian matrix
88 C integer listh(maxlh) : Nonzero hamiltonian-matrix element
89 C column indexes for each matrix row
90-C real*8 H(maxnh,nspin) : Hamiltonian in sparse form
91+C real*8 H(maxnh,spin%H) : Hamiltonian in sparse form
92 C real*8 S(maxnh) : Overlap in sparse form
93 C real*8 ef : Fermi energy
94 C real*8 xij(3,maxnh) : Vectors between orbital centers (sparse)
95 C (not used if only gamma point)
96 C integer no_u : First dimension of ek
97-C integer no_l : Second dimension of H and S
98-C integer indxuo(no_s) : Index of equivalent orbital in unit cell
99+C integer no_l : Second dimension of H and S
100+C integer indxuo(no_s) : Index of equivalent orbital in unit cell
101 C Unit cell orbitals must be the first in
102 C orbital lists, i.e. indxuo.le.no_l, with
103 C no_l the number of orbitals in unit cell
104 C real*8 ef : Fermi energy
105 C logical writeb : This routine must write bands?
106-C integer no_u : Total number of orbitals in unit cell
107+C integer no_u : Total number of orbitals in unit cell
108 C integer nk : Number of band k points
109 C real*8 kpoint(3,maxk) : k point vectors
110 C real*8 occtol : Occupancy threshold for DM build
111 C *************************** OUTPUT **********************************
112-C real*8 ek(no_u,maxspn,maxk) : Eigenvalues
113+C real*8 ek(no_u,spin%spinor,maxk) : Eigenvalues
114 C *************************** UNITS ***********************************
115 C Lengths in atomic units (Bohr).
116 C k vectors in reciprocal atomic units.
117@@ -366,7 +366,7 @@
118 use atmfuncs, only : symfio, cnfigfio, labelfis, nofis
119 use writewave, only : wfs_filename
120
121- use m_spin, only: NoMagn, SPpol, NonCol, SpOrb
122+ use t_spin, only: tSpin
123
124 use m_diag_option, only: ParallelOverK, Serial
125 use m_diag, only: diag_init
126@@ -374,13 +374,13 @@
127
128 implicit none
129
130- integer :: nspin
131- integer :: maxk, maxnh, maxspn, no_u, no_l, nk, no_s,
132+ type(tSpin), intent(in) :: spin
133+ integer :: maxk, maxnh, no_u, no_l, nk, no_s,
134 . indxuo(no_s), listh(maxnh), numh(no_l),
135- . listhptr(*), nuo
136+ . listhptr(*)
137 logical :: writeb
138- real(dp) :: ef, ek(no_u,maxspn,maxk),
139- . H(maxnh,nspin), kpoint(3,maxk),
140+ real(dp) :: ef, ek(no_u,spin%spinor,maxk),
141+ . H(maxnh,spin%H), kpoint(3,maxk),
142 . S(maxnh), xij(3,maxnh), occtol
143 logical, intent(in) :: getPSI
144
145@@ -394,7 +394,6 @@
146 logical, parameter :: fixspin = .false.
147
148 integer :: ik, il, io, ispin, iu, iu_wfs, iuo, naux, nhs, j
149-
150 logical :: SaveParallelOverK
151
152 real(dp)
153@@ -405,17 +404,10 @@
154 real(dp), dimension(:), pointer :: aux => null()
155
156 parameter ( eV = 1.d0 / 13.60580d0 )
157+
158 save Dnew, Enew, e1, e2, qk, qtot, temp, wk
159-
160 data Dnew, Enew, e1, e2, qk, qtot, temp, wk /8*0.d0/
161
162-C Get number of local orbitals
163-#ifdef MPI
164- call GetNodeOrbs(no_u,Node,Nodes,nuo)
165-#else
166- nuo = no_u
167-#endif
168-
169 C Start time counter
170 call timer( 'bands', 1 )
171
172@@ -430,12 +422,13 @@
173 endif
174
175 C Allocate local arrays - only aux is relevant here
176- if ( nspin >=4 ) then
177- nhs = 2 * (2*no_u) * (2*no_l)
178+
179+ if ( spin%Grid == 4 ) then
180+ nhs = 2 * (2*no_u) * (2*no_l)
181 else
182 nhs = 2 * no_u*no_l
183 endif
184- naux = 2*no_u*5
185+ naux = 2*no_u*5
186 call allocDenseMatrix(nhs, nhs, nhs)
187 call re_alloc( aux, 1, naux, 'aux', 'bands' )
188
189@@ -448,7 +441,7 @@
190 rewind (iu_wfs)
191
192 write(iu_wfs) nk, .false. ! nk, Gamma, same file-format in WFS as for Gamma-point
193- write(iu_wfs) nspin
194+ write(iu_wfs) spin%Grid
195 write(iu_wfs) no_u
196 write(iu_wfs) (iaorb(j),labelfis(isa(iaorb(j))),
197 . iphorb(j), cnfigfio(isa(iaorb(j)),iphorb(j)),
198@@ -458,7 +451,7 @@
199 endif
200
201 C Find the band energies
202- if (NoMagn .or. SPpol) then
203+ if ( spin%Grid < 4 ) then
204 C fixspin and qs are not used in diagk, since getD=.false. ...
205 qs(1) = 0.0_dp
206 qs(2) = 0.0_dp
207@@ -475,7 +468,7 @@
208 call diag_init()
209 end if
210
211- call diagk( nspin, no_l, no_s, maxspn,
212+ call diagk( spin%H, no_l, no_s, spin%spinor,
213 . maxnh, maxnh,
214 . no_u, numh, listhptr, listh, numh, listhptr,
215 . listh, H, S, getD, getPSI, fixspin, qtot, qs, temp,
216@@ -487,29 +480,17 @@
217 ParallelOverK = SaveParallelOverK
218 if ( ParallelOverK ) Serial = .true.
219
220- elseif ( NonCol ) then
221- if (getPSI) then
222- if (node==0) then
223- write(6,*) "No WFS for non-colinear spin, yet..."
224- endif
225- RETURN
226- endif
227+ elseif ( spin%NCol ) then
228 call diag2k(no_l, no_s, maxnh, maxnh, no_u,
229 . numh, listhptr, listh, numh, listhptr,
230- . listh, H, S, getD, qtot, temp, e1, e2,
231+ . listh, H, S, getD, getPSI, qtot, temp, e1, e2,
232 . xij, indxuo, nk, kpoint, wk,
233 . ek, qk, Dnew, Enew, ef, Entropy,
234 . Haux, Saux, psi, Haux, Saux, aux,
235 . no_u, occtol, 1, no_u )
236
237- elseif ( SpOrb ) then
238- if (getPSI) then
239- if (node==0) then
240- write(6,*) "No WFS for spin-orbit, yet..."
241- endif
242- return
243- end if
244- call diag3k(nuo, no_s, maxnh, maxnh, no_u, numh,
245+ elseif ( spin%SO ) then
246+ call diag3k(no_l, no_s, maxnh, maxnh, no_u, numh,
247 . listhptr, listh, numh, listhptr, listh,
248 . H, S, getD, getPSI, qtot, temp, e1, e2, xij,
249 . indxuo, nk, kpoint, wk, ek, qk, Dnew,
250@@ -517,7 +498,7 @@
251 . Haux, Saux, psi, Haux, Saux, aux,
252 . no_u, occtol, 1, no_u )
253 else
254- call die( 'bands: ERROR: incorrect value of nspin')
255+ call die( 'bands: ERROR: incorrect value of spin%H')
256 endif
257
258 C Write bands
259@@ -540,7 +521,7 @@
260 . path = path + sqrt( (kpoint(1,ik)-kpoint(1,ik-1))**2 +
261 . (kpoint(2,ik)-kpoint(2,ik-1))**2 +
262 . (kpoint(3,ik)-kpoint(3,ik-1))**2 )
263- do ispin = 1,maxspn
264+ do ispin = 1, spin%spinor
265 do io = 1, no_u
266 emax = max( emax, ek(io,ispin,ik) )
267 emin = min( emin, ek(io,ispin,ik) )
268@@ -552,13 +533,14 @@
269 write(iu,*) emin/eV, emax/eV
270
271 C Write eigenvalues
272- if ( nspin <= 2 ) then
273- write(iu,*) no_u, maxspn, nk
274- else if ( nspin <= 8 ) then
275- write(iu,*) 2*no_u, 1, nk
276- else
277- call die( 'bands: ERROR: incorrect value of nspin' )
278- end if
279+ if ( spin%Grid == 4 ) then
280+ write(iu,*) 2*no_u, 1, nk ! A single spin channel, double number of bands
281+ else
282+ write(iu,*) no_u, spin%spinor, nk
283+ endif
284+
285+ ! For non-collinear calculations, the ek array will contain the first no_u
286+ ! bands in ek(:,1,ik), and the next no_u bands in ek(:,2,ik)
287 path = 0.d0
288 do ik = 1,nk
289 if (nlines .ge. 0) then
290@@ -568,11 +550,11 @@
291 . (kpoint(3,ik)-kpoint(3,ik-1))**2 )
292 write(iu,'(f10.6,10f12.4,/,(10x,10f12.4))')
293 . path, ((ek(io,ispin,ik)/eV,io=1,no_u),
294- . ispin=1,maxspn)
295+ . ispin=1,spin%spinor)
296 else
297 write(iu,'(3f9.5,8f12.4,/,(27x,8f12.4))')
298 . kpoint(1,ik), kpoint(2,ik), kpoint(3,ik),
299- . ((ek(io,ispin,ik)/eV,io=1,no_u),ispin=1,maxspn)
300+ . ((ek(io,ispin,ik)/eV,io=1,no_u),ispin=1,spin%spinor)
301 endif
302 enddo
303
304
305=== modified file 'Src/diag2g.F'
306--- Src/diag2g.F 2018-06-25 11:33:42 +0000
307+++ Src/diag2g.F 2019-08-15 23:47:25 +0000
308@@ -7,7 +7,7 @@
309 !
310 subroutine diag2g( nuo, no, maxnh, maxnd, maxo,
311 . numh, listhptr, listh, numd, listdptr,
312- . listd, H, S, getD, qtot, temp, e1, e2,
313+ . listd, H, S, getD, getPSI, qtot, temp, e1, e2,
314 . eo, qo, Dnew, Enew, ef, Entropy,
315 . Haux, Saux, psi, caux,
316 . nuotot, occtol, iscf, neigwanted)
317@@ -19,6 +19,8 @@
318 use sys
319 use parallel, only : Node, Nodes, BlockSize
320 use parallelsubs, only : LocalToGlobalOrb,GlobalToLocalOrb
321+ use writewave, only : writew
322+ use iso_c_binding, only : c_loc, c_f_pointer
323 use m_fermid, only : fermid, stepf
324 use intrinsic_missing, only: MODP
325
326@@ -100,16 +102,19 @@
327 real(dp) Entropy, eo(maxo*2), H(maxnh,4), qo(maxo*2)
328 real(dp) qtot, S(maxnh), temp, occtol
329
330- complex(dp), dimension(2,nuotot,2*nuo) :: psi
331+ complex(dp), dimension(2,nuotot,2*nuo), target :: psi
332 complex(dp), dimension(2,nuotot,2,nuo) :: Haux, Saux
333- complex(dp), dimension(2,nuotot) :: caux
334- logical getD
335+ complex(dp), dimension(2,nuotot), target :: caux
336+ logical getD, getPSI
337
338 ! Internal variables .............................................
339
340+ real(dp), pointer :: psi_real_1d(:)
341+ real(dp), pointer :: aux(:)
342+
343 integer BNode, BTest, ie, ierror, iie, iio
344 integer ind, io, j, jo, nd, iuo, juo
345- real(dp) ee, pipj, qe, t
346+ real(dp) ee, pipj, qe, t, k(3)
347 complex(dp) :: cicj, D11, D22, D12, D21
348 #ifdef MPI
349 integer MPIerror
350@@ -201,6 +206,14 @@
351 call cdiag(Haux,Saux,2*nuotot,2*nuo,2*nuotot,eo,psi,
352 . 2*neigwanted,iscf,ierror, 2*BlockSize)
353 endif
354+
355+ if (getPSI) then
356+ k(1:3) = 0.0d0
357+ call c_f_pointer( c_loc(psi), psi_real_1d, [size(psi)*2] )
358+ call writew(nuotot,nuo,1,k,1,
359+ & eo,psi_real_1d,gamma=.true.,
360+ $ non_coll=.true., blocksize=2*BlockSize)
361+ endif
362
363 ! Check if we are done
364 if (.not.getD) goto 1001
365
366=== modified file 'Src/diag2k.F'
367--- Src/diag2k.F 2018-04-14 23:14:53 +0000
368+++ Src/diag2k.F 2019-08-15 23:47:25 +0000
369@@ -7,7 +7,7 @@
370 !
371 subroutine diag2k( nuo, no, maxnh, maxnd, maxo,
372 . numh, listhptr, listh, numd, listdptr,
373- . listd, H, S, getD, qtot, temp, e1, e2,
374+ . listd, H, S, getD, getPsi, qtot, temp, e1, e2,
375 . xij, indxuo, nk, kpoint, wk,
376 . eo, qo, Dnew, Enew, ef, Entropy,
377 . Haux, Saux, psi, Dk, Ek, caux,
378@@ -20,7 +20,9 @@
379 use sys
380 use parallel, only : Node, Nodes, BlockSize
381 use parallelsubs, only : LocalToGlobalOrb
382+ use writewave, only : writew
383 use m_fermid, only : fermid, stepf
384+ use iso_c_binding, only : c_loc, c_f_pointer
385 #ifdef MPI
386 use mpi_siesta
387 #endif
388@@ -79,8 +81,8 @@
389 C integer iscf : SCF cycle number
390 C integer neigwanted : Number of eigenvalues wanted
391 C *************************** OUTPUT **********************************
392-C real*8 eo(maxo*4,nk) : Eigenvalues
393-C real*8 qo(maxo*4,nk) : Occupations of eigenstates
394+C real*8 eo(maxo*2,nk) : Eigenvalues
395+C real*8 qo(maxo*2,nk) : Occupations of eigenstates
396 C real*8 Dnew(maxnd,4) : Output Density Matrix
397 C real*8 Enew(maxnd,4) : Output Energy-Density Matrix
398 C real*8 ef : Fermi energy
399@@ -116,11 +118,15 @@
400 integer :: neigwanted
401
402 complex(dp), dimension(2,nuotot,2,nuo) :: Haux, Saux, Dk, Ek
403- complex(dp), dimension(2,nuotot,2*nuo) :: psi
404- complex(dp), dimension(2,nuotot) :: caux
405- logical getD
406+ complex(dp), dimension(2,nuotot,2*nuo), target :: psi
407+ complex(dp), dimension(2,nuotot), target :: caux
408+ logical, intent(in) :: getD, getPsi
409
410 ! Internal variables .............................................
411+
412+ ! For interface compliance using c_f_pointer
413+ real(dp), pointer :: aux(:)
414+ real(dp), pointer :: psi_real(:)
415
416 integer BNode, BTest, ie, ierror, iie, ik, ind, io, iio
417 integer iuo, j, jo, juo, neigneeded
418@@ -170,6 +176,9 @@
419 !
420 ! 1. Hermiticity imposes H_{i,j}^{is,js}=H_{j,i}^{js,is}^*
421
422+ ! Jump point for bands and wfs output only
423+ if (getPSI .and. (.not. GetD)) goto 10
424+
425 ! Find eigenvalues at every k point
426 do ik = 1,nk
427
428@@ -214,10 +223,10 @@
429 endif
430 enddo
431
432-!-----------------------------------------------------------------------
433-! Check if we are done
434-!-----------------------------------------------------------------------
435- if (.not.getD) goto 1001
436+ ! Check if we are done (i.e.: pure bands only)
437+ if (.not.getD .and. .not. getPSI) then
438+ RETURN
439+ end if
440 !-----------------------------------------------------------------------
441
442 ! Find new Fermi energy and occupation weights
443@@ -240,16 +249,23 @@
444 Dnew(:,:) = 0.0_dp
445 Enew(:,:) = 0.0_dp
446
447-! Find maximum eigenvector that is required for this k point
448+ 10 continue ! ---- Start here for (getPsi and (not getDM))
449+
450 do ik = 1,nk
451- neigneeded = 0
452- ie = 2*nuotot
453- do while (ie.gt.0.and.neigneeded.eq.0)
454- qe = qo(ie,ik)
455- if (abs(qe).gt.occtol) neigneeded = ie
456- ie = ie - 1
457- enddo
458-
459+ ! Find maximum eigenvector index that is required for this k point
460+ if (getPSI) then
461+ ! We do not have info about occupation
462+ neigneeded = neigwanted
463+ else
464+ neigneeded = 0
465+ ie = 2*nuotot ! for mixed spins
466+ do while (ie.gt.0.and.neigneeded.eq.0)
467+ qe = qo(ie,ik)
468+ if (abs(qe).gt.occtol) neigneeded = ie
469+ ie = ie - 1
470+ enddo
471+ endif
472+
473 ! Find eigenvectors
474 Saux = dcmplx(0.0_dp,0.0_dp)
475 Haux = dcmplx(0.0_dp,0.0_dp)
476@@ -310,8 +326,25 @@
477 call cdiag(Haux,Saux,2*nuotot,2*nuo,2*nuotot,caux,psi,
478 . neigneeded,iscf,ierror,2*BlockSize)
479 endif
480-
481-!-----------------------------------------------------------------------
482+
483+
484+ if (getPSI) then
485+ if (.not. getD) then
486+ ! Fill in the missing eigenvalue information
487+ ! This is useful if we are requesting WFS in a "bands" setting
488+ call c_f_pointer(c_loc(caux),aux,[2*nuotot])
489+ call kludge_copy(2*nuotot,eo(1,ik),aux)
490+ endif
491+ call c_f_pointer(c_loc(psi),psi_real,[2*size(psi)])
492+ call writew(nuotot,nuo,ik,kpoint(1,ik),1, ! last '1' is 'spin-block number'
493+ . eo(1,ik), ! energies
494+ . psi_real,gamma=.false.,non_coll=.true.,
495+ $ blocksize=2*BlockSize)
496+ endif
497+
498+ if (.not. getD) CYCLE ! process new k-point
499+
500+!-----------------------------------------------------------------------
501 ! Store the products of eigenvectors in matrices Dk and Ek
502 ! WARNING: Dk and Ek may be EQUIVALENCE'd to Haux and Saux
503 !-----------------------------------------------------------------------
504@@ -445,13 +478,22 @@
505
506 enddo
507 enddo
508- enddo
509+ enddo ! over k-points
510
511- 1001 continue
512-
513 #ifdef DEBUG
514 call write_debug( ' POS diag2k' )
515 #endif
516+
517+ CONTAINS
518+ ! Work around shape of aux array
519+ subroutine kludge_copy(n,a,b)
520+ integer, intent(in) :: n
521+ real(dp), intent(out) :: a(n)
522+ real(dp), intent(in) :: b(n)
523+!$OMP parallel workshare default(shared)
524+ a(1:n) = b(1:n)
525+!$OMP end parallel workshare
526+ end subroutine kludge_copy
527
528 end subroutine diag2k
529
530
531=== modified file 'Src/diag3g.F'
532--- Src/diag3g.F 2018-06-25 11:33:42 +0000
533+++ Src/diag3g.F 2019-08-15 23:47:25 +0000
534@@ -5,7 +5,7 @@
535 ! or http://www.gnu.org/copyleft/gpl.txt.
536 ! See Docs/Contributors.txt for a list of contributors.
537 !
538- subroutine diag3g( nuo, no, maxuo, maxnh, maxnd, maxo,
539+ subroutine diag3g( nuo, no, maxnh, maxnd, maxo,
540 . numh, listhptr, listh, numd, listdptr,
541 . listd, H, S, getD, getPSI, qtot, temp, e1, e2,
542 . eo, qo, Dnew, Enew, ef, Entropy,
543@@ -16,8 +16,10 @@
544 use sys
545 use parallel, only : Node, Nodes, BlockSize
546 use parallelsubs, only : LocalToGlobalOrb,GlobalToLocalOrb
547+ use writewave, only : writew
548 use m_fermid, only : fermid, stepf
549 use intrinsic_missing, only: MODP
550+ use iso_c_binding, only : c_loc, c_f_pointer
551 #ifdef MPI
552 use mpi_siesta
553 #endif
554@@ -33,7 +35,6 @@
555 C **************************** INPUT **********************************
556 C integer nuo : Number of basis orbitals on local node
557 C integer no : Number of basis orbitals
558-C integer maxuo : Maximum number of basis orbitals
559 C integer maxnh : Maximum number of orbitals interacting
560 C integer maxnd : First dimension of Dnew and Enew
561 C integer maxo : First dimension of eo and qo
562@@ -86,7 +87,7 @@
563 ! Indices is and js are for spin components
564 ! Indices iuo and juo are for orbital components:
565 ! *********************************************************************
566- integer maxo, maxuo, maxnd, maxnh
567+ integer maxo, maxnd, maxnh
568 integer no, nuo, nuotot, iscf, neigwanted
569
570 integer listh(maxnh), numh(nuo), listhptr(nuo)
571@@ -96,7 +97,8 @@
572 real(dp) Entropy, eo(maxo*2), H(maxnh,8), qo(maxo*2)
573 real(dp) qtot, S(maxnh), temp, occtol
574
575- complex(dp), dimension(2,nuotot,2*nuo) :: psi
576+ complex(dp), dimension(2,nuotot,2*nuo), target :: psi
577+ real(dp), pointer :: psi_real_1d(:)
578 complex(dp), dimension(2,nuotot,2,nuo) :: Haux, Saux
579 complex(dp), dimension(2,nuotot) :: caux
580 logical getD, getPSI
581@@ -105,7 +107,7 @@
582
583 integer BNode, BTest, ie, ierror, iie, iio
584 integer ind, io, j, jo, nd, iuo, juo
585- real(dp) ee, qe, t
586+ real(dp) ee, qe, t, k(3)
587 complex(dp) D11, D22, D12, D21
588 #ifdef MPI
589 integer MPIerror
590@@ -193,7 +195,20 @@
591 call cdiag(Haux,Saux,2*nuotot,2*nuo,2*nuotot,eo,psi,
592 . 2*neigwanted,iscf,ierror,2*BlockSize)
593 endif
594-
595+
596+ if (getPSI) then
597+ k(1:3) = 0.0d0
598+
599+ ! We do not have info about occupation
600+ ! In the current implementation, neigneeded
601+ ! is ALWAYS nuotot.
602+ ! This is because writewave expects the full spectrum
603+ call c_f_pointer( c_loc(psi), psi_real_1d, [size(psi)*2] )
604+ call writew(nuotot,nuo,1,k,1,
605+ & eo,psi_real_1d,gamma=.true.,
606+ $ non_coll=.true.,blocksize=2*BlockSize)
607+ endif
608+
609 ! Check if we are done
610 if (.not.getD) return
611
612
613=== modified file 'Src/diag3k.F'
614--- Src/diag3k.F 2017-08-06 11:17:47 +0000
615+++ Src/diag3k.F 2019-08-15 23:47:25 +0000
616@@ -18,7 +18,9 @@
617 use sys
618 use parallel, only : Node, Nodes, BlockSize
619 use parallelsubs, only : LocalToGlobalOrb
620+ use writewave, only : writew
621 use m_fermid, only : fermid, stepf
622+ use iso_c_binding, only : c_f_pointer, c_loc
623 #ifdef MPI
624 use mpi_siesta
625 #endif
626@@ -114,12 +116,14 @@
627 integer :: neigwanted
628
629 complex(dp), dimension(2,nuotot,2,nuo) :: Haux, Saux, Dk, Ek
630- complex(dp), dimension(2,nuotot,2*nuo) :: psi
631- complex(dp), dimension(2,nuotot) :: caux
632- logical getD, getPSI
633-
634-! TEMPOS, INTERNAL VARIABLES etc.
635-
636+ complex(dp), dimension(2,nuotot,2*nuo), target :: psi
637+ complex(dp), dimension(2,nuotot), target :: caux
638+ logical, intent(in) :: getD, getPSI
639+
640+
641+ real(dp), pointer :: aux(:)
642+ real(dp), pointer :: psi_real(:)
643+
644 integer BNode, BTest, ie, ierror, iie, ik, ind, io, iio
645 integer iuo, j, jo, juo, neigneeded
646 real(dp) ee, qe, t
647@@ -175,6 +179,9 @@
648 !
649 !
650
651+ ! Jump point for bands and wfs output only
652+ if (getPSI .and. (.not. GetD)) goto 10
653+
654 ! Find eigenvalues at every k point
655
656 do ik = 1,nk
657@@ -214,11 +221,11 @@
658 call die('Terminating due to failed diagonalisation')
659 endif
660 enddo
661-
662-!-----------------------------------------------------------------------
663-! Check if we are done
664-!-----------------------------------------------------------------------
665- if (.not.getD) return
666+
667+ ! Check if we are done (i.e.: pure bands only)
668+ if (.not.getD .and. .not. getPSI) then
669+ RETURN
670+ end if
671 !-----------------------------------------------------------------------
672
673 ! Find new Fermi energy and occupation weights
674@@ -240,16 +247,23 @@
675 ! New density and energy-density matrices of unit-cell orbitals
676 Dnew(:,:) = 0.0_dp
677 Enew(:,:) = 0.0_dp
678+
679+ 10 continue ! ---- Start here for (getPsi and (not getDM))
680
681-! Find maximum eigenvector that is required for this k point
682 do ik = 1,nk
683- neigneeded = 0
684- ie = 2*nuotot ! for mixed spins
685- do while (ie.gt.0.and.neigneeded.eq.0)
686- qe = qo(ie,ik)
687- if (abs(qe).gt.occtol) neigneeded = ie
688- ie = ie - 1
689- enddo
690+ ! Find maximum eigenvector index that is required for this k point
691+ if (getPSI) then
692+ ! We do not have info about occupation
693+ neigneeded = neigwanted
694+ else
695+ neigneeded = 0
696+ ie = 2*nuotot ! for mixed spins
697+ do while (ie.gt.0.and.neigneeded.eq.0)
698+ qe = qo(ie,ik)
699+ if (abs(qe).gt.occtol) neigneeded = ie
700+ ie = ie - 1
701+ enddo
702+ endif
703
704 ! Find eigenvectors
705 Saux = dcmplx(0.0_dp,0.0_dp)
706@@ -314,6 +328,22 @@
707 . neigneeded,iscf,ierror, 2*BlockSize)
708 endif
709
710+ if (getPSI) then
711+ if (.not. getD) then
712+ ! Fill in the missing eigenvalue information
713+ ! This is useful if we are requesting WFS in a "bands" setting
714+ call c_f_pointer(c_loc(caux),aux,[2*nuotot])
715+ call kludge_copy(2*nuotot,eo(1,ik),aux)
716+ endif
717+ call c_f_pointer(c_loc(psi),psi_real,[2*size(psi)])
718+ call writew(nuotot,nuo,ik,kpoint(1,ik),1, ! last '1' is 'spin-block number'
719+ . eo(1,ik), ! energies
720+ . psi_real,gamma=.false.,non_coll=.true.,
721+ $ blocksize=2*BlockSize)
722+ endif
723+
724+ if (.not. getD) CYCLE ! process new k-point
725+
726 !***********************************************************************
727 ! BUILD NEW DENSITY MATRIX
728 !***********************************************************************
729@@ -429,8 +459,18 @@
730 enddo
731 enddo
732
733-!***********************************************************************
734- return
735+ CONTAINS
736+ ! Work around shape of aux array
737+ subroutine kludge_copy(n,a,b)
738+ integer, intent(in) :: n
739+ real(dp), intent(out) :: a(n)
740+ real(dp), intent(in) :: b(n)
741+!$OMP parallel workshare default(shared)
742+ a(1:n) = b(1:n)
743+!$OMP end parallel workshare
744+ end subroutine kludge_copy
745+
746 end subroutine diag3k
747 !***********************************************************************
748+
749
750
751=== modified file 'Src/diagg.F'
752--- Src/diagg.F 2018-06-25 11:33:42 +0000
753+++ Src/diagg.F 2019-08-15 23:47:25 +0000
754@@ -91,7 +91,7 @@
755 use m_spin, only : spinor_dim, e_spin_dim
756 use alloc
757 use intrinsic_missing, only: MODP
758-
759+ use iso_c_binding, only : c_f_pointer, c_loc
760 #ifdef MPI
761 use mpi_siesta
762 #endif
763@@ -117,10 +117,9 @@
764 & qo(maxo,spinor_dim), qtot, qs(spinor_dim), S(maxnh), temp,
765 & efs(spinor_dim), occtol
766
767- real(dp)
768- & Haux(nuotot,nuo), Saux(nuotot,nuo),
769- & psi(nuotot,maxuo,spinor_dim)
770-
771+ real(dp) Haux(nuotot,nuo), Saux(nuotot,nuo)
772+ real(dp), target :: psi(nuotot,maxuo,spinor_dim)
773+ real(dp), pointer :: psi_real_1d(:)
774 real(dp), dimension(1), parameter :: wk = (/ 1.0_dp /)
775 integer, parameter :: nk = 1
776
777@@ -203,8 +202,11 @@
778 do ix = 1,3
779 k(ix) = 0.0d0
780 enddo
781+ call c_f_pointer(c_loc(psi(:,:,ispin)),psi_real_1d,
782+ $ [size(psi,1)*size(psi,2)])
783 call writew(nuotot,nuo,1,k,ispin,
784- & eo(1,ispin),psi(1,1,ispin),.true.)
785+ & eo(1,ispin),psi_real_1d,gamma=.true.,
786+ $ non_coll=.false.,blocksize=BlockSize)
787 endif
788
789 enddo
790
791=== modified file 'Src/diagk.F'
792--- Src/diagk.F 2017-08-06 09:35:09 +0000
793+++ Src/diagk.F 2019-08-15 23:47:25 +0000
794@@ -101,6 +101,7 @@
795 use writewave, only : writew
796 use m_fermid, only : fermid, fermispin, stepf
797 use m_spin, only : spinor_dim, e_spin_dim
798+ use iso_c_binding, only : c_loc, c_f_pointer
799 #ifdef MPI
800 use mpi_siesta
801 #endif
802@@ -143,6 +144,7 @@
803 real(dp) :: qp1, qp2, eqp1, eqp2
804
805 real(dp), pointer :: lpsi(:,:)
806+ real(dp), pointer :: psi_real_1d(:)
807
808 logical, allocatable :: done_juo(:)
809 C ....................
810@@ -347,8 +349,10 @@
811 ! This is useful if we are requesting WFS in a "bands" setting
812 call kludge_copy(nuotot,eo(1,ispin,ik),aux)
813 endif
814+ call c_f_pointer(c_loc(psi),psi_real_1d,[size(psi)])
815 call writew(nuotot,nuo,ik,kpoint(1,ik),ispin,
816- . aux,psi,.false.)
817+ . aux,psi_real_1d,gamma=.false.,non_coll=.false.,
818+ $ blocksize=BlockSize)
819 endif
820
821 if (getD) then
822
823=== modified file 'Src/diagon.F'
824--- Src/diagon.F 2018-11-02 09:03:25 +0000
825+++ Src/diagon.F 2019-08-15 23:47:25 +0000
826@@ -266,7 +266,7 @@
827 if (gamma) then
828 call diag2g( nuo, no, maxnh, maxnd, maxo, numh,
829 . listhptr, listh, numd, listdptr, listd,
830- . H, S, getD, qtot, temp, e1, e2, eo, qo,
831+ . H, S, getD, getPSI, qtot, temp, e1, e2, eo, qo,
832 . Dnew, Enew, ef, Entropy,
833 . Haux, Saux, psi, aux,
834 . nuotot, occtol, iscf, neigwanted )
835@@ -281,7 +281,7 @@
836 else
837 call diag2k( nuo, no, maxnh, maxnd, maxo, numh,
838 . listhptr, listh, numd, listdptr, listd,
839- . H, S, getD, qtot, temp, e1, e2, xij,
840+ . H, S, getD, getPsi, qtot, temp, e1, e2, xij,
841 . indxuo, nk, kpoint, wk, eo, qo, Dnew,
842 . Enew, ef, Entropy,
843 . Haux, Saux, psi, Haux, Saux, aux,
844@@ -289,7 +289,7 @@
845 endif
846 elseif ( spin%SO ) then
847 if (gamma) then
848- call diag3g( nuo, no, maxuo, maxnh, maxnd, maxo, numh,
849+ call diag3g( nuo, no, maxnh, maxnd, maxo, numh,
850 . listhptr, listh, numd, listdptr, listd,
851 . H, S, getD, getPSI, qtot, temp, e1, e2, eo, qo,
852 . Dnew, Enew, ef, Entropy,
853
854=== modified file 'Src/ioeig.f'
855--- Src/ioeig.f 2018-05-08 11:36:55 +0000
856+++ Src/ioeig.f 2019-08-15 23:47:25 +0000
857@@ -19,10 +19,10 @@
858
859 implicit none
860
861- integer, intent(in) :: no
862- integer, intent(in) :: nspin
863+ integer, intent(in) :: no ! no_u: number of orbitals in unit cell
864+ integer, intent(in) :: nspin ! 'nspin_grid': 1, 2, or 4
865 integer, intent(in) :: nk
866- integer, intent(in) :: maxo
867+ integer, intent(in) :: maxo ! no_u again
868 integer, intent(in) :: nspinor
869 integer, intent(in) :: maxk
870 real(dp), intent(in) :: ef
871@@ -45,11 +45,17 @@
872
873 write(iu,"(e17.9)") ef/eV
874 if ( nspin > nspinor ) then
875- write(iu,"(tr1,i10,i2,tr1,i10)") no*2, 1, nk
876+ ! NC/SOC case: a single block of wavefunctions (without spin tag)
877+ ! nspin (4) will be used here to signal NC/SOC to utilities such as
878+ ! Eig2DOS
879+ write(iu,"(tr1,i10,i2,tr1,i10)") no*2, nspin, nk
880 else
881 write(iu,"(tr1,i10,i2,tr1,i10)") no, min(nspin,2), nk
882 end if
883 do ik = 1,nk
884+ ! This statement will correctly print eo in the NC/SOC case,
885+ ! as the eigenvalues take up two complete 'io' columns,
886+ ! and nspinor = 2.
887 write(iu,"(i10,10(tr1,e17.9),/,(tr10,10(tr1,e17.9)))")
888 . ik, ((eo(io,is,ik)/eV,io=1,no),is=1,nspinor)
889 enddo
890@@ -83,7 +89,7 @@
891 if ( is == 1 .and. nspinor > 1 ) then
892 call cmlAddProperty(xf=mainXML, value="up",
893 . dictRef="siesta:spin")
894- else if ( nspinor > 1 ) then
895+ else if ( nspinor > 1) then
896 call cmlAddProperty(xf=mainXML, value="down",
897 . dictRef="siesta:spin")
898 end if
899
900=== modified file 'Src/m_spin.F90'
901--- Src/m_spin.F90 2019-01-13 16:11:47 +0000
902+++ Src/m_spin.F90 2019-08-15 23:47:25 +0000
903@@ -355,6 +355,8 @@
904 write(*,'(a)') repeat('#',60)
905 write(*,'(a,t16,a,t60,a)') '#','Spin-orbit coupling is in beta','#'
906 write(*,'(a,t13,a,t60,a)') '#','Several options may not be compatible','#'
907+ call message("WARNING","This spin-orbit implementation uses a local approximation.")
908+ call message("WARNING","You are strongly advised to use the newer version.")
909 write(*,'(a)') repeat('#',60)
910 end if
911
912
913=== modified file 'Src/print_spin.F90'
914--- Src/print_spin.F90 2018-04-11 09:52:01 +0000
915+++ Src/print_spin.F90 2019-08-15 23:47:25 +0000
916@@ -2,10 +2,10 @@
917 !
918 ! Prints spin in output and CML files
919 !
920- use m_spin, only: nspin
921+ use m_spin, only: spin
922 use atomlist, only: no_l
923 use sparse_matrices, only: listhptr, numh
924- use sparse_matrices, only: S, Dscf
925+ use sparse_matrices, only: S, Dscf ! Dscf could have 1, 2, 4, or 8 components
926 use siesta_cml
927 use parallel, only: IOnode
928 use precision, only: dp
929@@ -15,58 +15,73 @@
930
931 implicit none
932
933- real(dp), intent(out) :: qspin(4)
934+ real(dp), intent(out) :: qspin(spin%Grid)
935
936 integer :: ispin, io, j, ind
937 real(dp) :: qaux
938 real(dp) :: Stot ! Total spin magnitude
939 real(dp) :: Svec(3) ! Total spin vector
940 #ifdef MPI
941- real(dp) :: qtmp(4)
942-#endif
943-
944- if (nspin .ge. 2) then
945- do ispin = 1,nspin
946- qspin(ispin) = 0.0_dp
947- do io = 1,no_l
948- do j = 1,numh(io)
949- ind = listhptr(io)+j
950- qspin(ispin) = qspin(ispin) + Dscf(ind,ispin) * S(ind)
951- enddo
952- enddo
953- enddo
954-
955-#ifdef MPI
956- ! Global reduction of spin components
957- call globalize_sum(qspin(1:nspin),qtmp(1:nspin))
958- qspin(1:nspin) = qtmp(1:nspin)
959-#endif
960-
961- if (nspin .eq. 2) then
962-
963- if (IOnode) then
964- Svec(1) = 0.0_dp
965- Svec(2) = 0.0_dp
966- Svec(3) = qspin(1) - qspin(2)
967- Stot = Svec(3)
968- write(6,'(5x,a,f10.5,2f10.1,f10.5)') 'spin moment: S , {S} = ', Stot, Svec
969- endif
970- if (cml_p) call cmlAddProperty(xf=mainXML, &
971- value=qspin(1)-qspin(2), dictref='siesta:stot', &
972- units='siestaUnits:spin')
973-
974- elseif (nspin .eq. 4) then
975-
976- call spnvec( nspin, qspin, qaux, Stot, Svec )
977- if (IONode) then
978- write(6,'(5x,a,4f10.5)') 'spin moment: S , {S} = ', Stot, Svec
979- if (cml_p) then
980- call cmlAddProperty(xf=mainXML, value=Stot, &
981- dictref='siesta:stot', units='siestaUnits:spin')
982- call cmlAddProperty(xf=mainXML, value=Svec, &
983- dictref='siesta:svec', units='siestaUnits:spin')
984- endif !cml_p
985- endif
986- endif
987+ real(dp) :: qtmp(spin%Grid)
988+#endif
989+
990+ qspin(:) = 0.0_dp
991+
992+ if ( spin%Grid < 2 ) return
993+
994+ if ( spin%SO ) then
995+
996+ do io = 1,no_l
997+ do j = 1,numh(io)
998+ ind = listhptr(io)+j
999+ ! In the SOC case, hermitify Dscf
1000+ qspin(1:2) = qspin(1:2) + dscf(ind,1:2) * S(ind)
1001+ qspin(3) = qspin(3) + 0.5_dp*(dscf(ind,3)+dscf(ind,7)) * S(ind)
1002+ qspin(4) = qspin(4) + 0.5_dp*(dscf(ind,4)+dscf(ind,8)) * S(ind)
1003+ end do
1004+ end do
1005+
1006+ else
1007+
1008+ do io = 1,no_l
1009+ do j = 1,numh(io)
1010+ ind = listhptr(io)+j
1011+ qspin(:) = qspin(:) + Dscf(ind,:) * S(ind)
1012+ end do
1013+ end do
1014+
1015 endif
1016+#ifdef MPI
1017+ ! Global reduction of spin components
1018+ call globalize_sum(qspin(1:spin%Grid),qtmp(1:spin%Grid))
1019+ qspin(1:spin%Grid) = qtmp(1:spin%Grid)
1020+#endif
1021+
1022+ ! We are left with printing out to stdout
1023+ if ( .not. IONode ) return
1024+
1025+ if ( spin%Grid == 2) then
1026+
1027+ Svec(1) = 0.0_dp
1028+ Svec(2) = 0.0_dp
1029+ Svec(3) = qspin(1) - qspin(2)
1030+ Stot = Svec(3)
1031+ write(6,'(5x,a,f10.5,2f10.1,f10.5)') 'spin moment: S , {S} = ', Stot, Svec
1032+ if (cml_p) call cmlAddProperty(xf=mainXML, &
1033+ value=qspin(1)-qspin(2), dictref='siesta:stot', &
1034+ units='siestaUnits:spin')
1035+
1036+ else if ( spin%Grid == 4 ) then
1037+
1038+ call spnvec( spin%Grid, qspin, qaux, Stot, Svec )
1039+ write(6,'(5x,a,4f10.5)') 'spin moment: S , {S} = ', Stot, Svec
1040+ if (cml_p) then
1041+ call cmlAddProperty(xf=mainXML, value=Stot, &
1042+ dictref='siesta:stot', units='siestaUnits:spin')
1043+ call cmlAddProperty(xf=mainXML, value=Svec, &
1044+ dictref='siesta:svec', units='siestaUnits:spin')
1045+ end if !cml_p
1046+
1047+ end if
1048+
1049 end subroutine print_spin
1050
1051=== modified file 'Src/siesta_analysis.F'
1052--- Src/siesta_analysis.F 2018-06-25 11:33:42 +0000
1053+++ Src/siesta_analysis.F 2019-08-15 23:47:25 +0000
1054@@ -46,8 +46,7 @@
1055 use m_energies
1056 use m_steps, only: final
1057 use m_ntm
1058- use m_spin, only: nspin, spinor_dim, h_spin_dim
1059- use m_spin, only: SpOrb, NonCol, SPpol, NoMagn
1060+ use m_spin, only: spin
1061 use m_dipol
1062 use m_eo
1063 use m_forces, only: fa
1064@@ -68,15 +67,15 @@
1065
1066 real(dp) :: dummy_str(3,3)
1067 real(dp) :: dummy_strl(3,3)
1068- real(dp) :: qspin(4) ! Local
1069+ real(dp) :: qspin(spin%Grid) ! Local
1070
1071- real(dp) :: polxyz(3,nspin) ! Autom., small
1072- real(dp) :: polR(3,nspin) ! Autom., small
1073+ real(dp) :: polxyz(3,spin%Grid) ! Autom., small
1074+ real(dp) :: polR(3,spin%Grid) ! Autom., small
1075 real(dp) :: qaux
1076 real(dp), pointer :: ebk(:,:,:) ! Band energies
1077
1078 integer :: j, ix, ind, ik, io, ispin
1079- integer :: wfs_band_min, wfs_band_max
1080+ integer :: wfs_band_min, wfs_band_max, max_n_states
1081 real(dp) :: g2max, current_ef
1082 type(filesOut_t) :: filesOut ! blank output file names
1083
1084@@ -127,7 +126,7 @@
1085
1086 if (fdf_get("Read-H-from-file",.false.)) then
1087 if (SIESTA_worker) then
1088- call read_spmatrix(maxnh, no_l, h_spin_dim, numh,
1089+ call read_spmatrix(maxnh, no_l, spin%H, numh,
1090 . listhptr, listh, H, found, userfile="H_IN")
1091 if (.not. found) call die("Could not find H_IN")
1092 current_ef = ef
1093@@ -137,7 +136,7 @@
1094
1095 #ifdef SIESTA__PEXSI
1096 if (fdf_get("PEXSI.DOS",.false.)) then
1097- call pexsi_dos(no_u, no_l, spinor_dim,
1098+ call pexsi_dos(no_u, no_l, spin%spinor,
1099 $ maxnh, numh, listhptr, listh, H, S, qtot, ef)
1100
1101 endif
1102@@ -263,6 +262,17 @@
1103 ! latest DM, although this is probably too much).
1104 ! See the logic in siesta_forces.
1105
1106+! Setup the number of states depending on the used method
1107+! For polarized calculations we use no_u and separate spin-channels.
1108+! For NC/SO we have mixed spin-channels and separating makes no
1109+! sense.
1110+ if ( spin%Grid == 4 ) then
1111+! We are NC/SO
1112+ max_n_states = no_u * 2
1113+ else
1114+ max_n_states = no_u
1115+ end if
1116+
1117 ! Find and print wavefunctions at selected k-points
1118 !** This uses H,S, and xa
1119 if (nwk.gt.0) then
1120@@ -270,7 +280,7 @@
1121 if (IONode) print "(a)",
1122 $ "Writing WFSX for selected k-points in "
1123 $ // trim(wfs_filename)
1124- call wwave( no_s, h_spin_dim, spinor_dim, no_u, no_l, maxnh,
1125+ call wwave( no_s, spin, no_u, no_l, maxnh,
1126 & nwk,
1127 & numh, listhptr, listh, H, S, Ef, xijo, indxuo,
1128 & gamma_wavefunctions, nwk, wfk, no_u, occtol )
1129@@ -278,19 +288,20 @@
1130
1131
1132 !** This uses H,S, and xa
1133- if (write_coop) then
1134+ if ( write_coop ) then
1135 ! Output the wavefunctions for the kpoints in the SCF set
1136 ! Note that we allow both a band number and an energy range
1137 ! The user is responsible for using appropriate values.
1138 wfs_band_min = fdf_get("WFS.BandMin",1)
1139- wfs_band_max = fdf_get("WFS.BandMax",no_u)
1140- call setup_wfs_list(nkpnt,no_u,wfs_band_min,wfs_band_max,
1141+ wfs_band_max = fdf_get("WFS.BandMax",max_n_states)
1142+ call setup_wfs_list(nkpnt,max_n_states,
1143+ $ wfs_band_min,wfs_band_max,
1144 $ use_scf_weights=.true.,
1145 $ use_energy_window=.true.)
1146 wfs_filename = trim(slabel)//".fullBZ.WFSX"
1147 if (IONode) print "(a)", "Writing WFSX for COOP/COHP in "
1148 $ // trim(wfs_filename)
1149- call wwave( no_s, h_spin_dim, spinor_dim, no_u, no_l, maxnh,
1150+ call wwave( no_s, spin, no_u, no_l, maxnh,
1151 . nkpnt,
1152 . numh, listhptr, listh, H, S, Ef, xijo, indxuo,
1153 . gamma_SCF, nkpnt, kpoint, no_u, occtol)
1154@@ -299,82 +310,101 @@
1155 ! Compute bands
1156 !** This uses H,S, and xa
1157 nullify( ebk )
1158- call re_alloc( ebk, 1, no_u, 1, spinor_dim, 1, maxbk,
1159- & 'ebk', 'siesta_analysis' )
1160-
1161- if (nbk.gt.0) then
1162+ if ( spin%Grid == 4 ) then
1163+ call re_alloc( ebk, 1, no_u*2, 1, 1, 1, maxbk,
1164+ & 'ebk', 'siesta_analysis' )
1165+ else
1166+ call re_alloc( ebk, 1, no_u, 1, spin%spinor, 1, maxbk,
1167+ & 'ebk', 'siesta_analysis' )
1168+ end if
1169+
1170+ if ( nbk > 0 ) then
1171 if (IONode) print "(a)", "Computing bands..."
1172 getPSI = fdf_get('WFS.Write.For.Bands', .false.)
1173 if (getPSI) then
1174- wfs_filename = trim(slabel)//".bands.WFSX"
1175- if (IONode) print "(a)", "Writing WFSX for bands in "
1176- $ // trim(wfs_filename)
1177- wfs_band_min = fdf_get("WFS.BandMin",1)
1178- wfs_band_max = fdf_get("WFS.BandMax",no_u)
1179- call setup_wfs_list(nbk,no_u,wfs_band_min,wfs_band_max,
1180- $ use_scf_weights=.false.,
1181- $ use_energy_window=.false.)
1182- endif
1183- call bands( no_s, h_spin_dim, spinor_dim, no_u, no_l, maxnh,
1184+ wfs_filename = trim(slabel)//".bands.WFSX"
1185+ if (IONode) print "(a)", "Writing WFSX for bands in "
1186+ $ // trim(wfs_filename)
1187+ wfs_band_min = fdf_get("WFS.BandMin",1)
1188+ wfs_band_max = fdf_get("WFS.BandMax",max_n_states)
1189+ call setup_wfs_list(nbk,max_n_states,
1190+ $ wfs_band_min,wfs_band_max,
1191+ $ use_scf_weights=.false.,
1192+ $ use_energy_window=.false.)
1193+ end if
1194+ call bands( no_s, spin, no_u, no_l, maxnh,
1195 . maxbk,
1196 . numh, listhptr, listh, H, S, Ef, xijo, indxuo,
1197- . .true., nbk, bk, ebk, occtol, getPSI )
1198- if (IOnode) then
1199+ . .true., nbk, bk, ebk, occtol, getPSI )
1200+
1201+ if ( IOnode ) then
1202 if ( writbk ) then
1203- write(6,'(/,a,/,a4,a12)')
1204- & 'siesta: Band k vectors (Bohr**-1):', 'ik', 'k'
1205+ write(6,'(/,a,/,a4,tr1,a12)')
1206+ & 'siesta: Band k vectors (Bohr**-1):', 'ik', 'k'
1207 do ik = 1,nbk
1208- write(6,'(i4,3f12.6)') ik, (bk(ix,ik),ix=1,3)
1209- enddo
1210- endif
1211+ write(6,'(i4,3(tr1,f12.6))') ik, (bk(ix,ik),ix=1,3)
1212+ end do
1213+ end if
1214
1215 if ( writb ) then
1216- write(6,'(/,a,/,a4,a3,a7)')
1217- & 'siesta: Band energies (eV):', 'ik', 'is', 'eps'
1218- do ispin = 1, spinor_dim
1219+ if ( spin%Grid == 4 ) then
1220+ write(6,'(/,a,/,a4,tr1,a9)')
1221+ & 'siesta: Band energies (eV):', 'ik', 'eps'
1222 do ik = 1,nbk
1223- write(6,'(i4,i3,10f7.2)')
1224- & ik, ispin, (ebk(io,ispin,ik)/eV,io=1,min(10,no_u))
1225- if (no_u.gt.10) write(6,'(7x,10f7.2)')
1226- & (ebk(io,ispin,ik)/eV,io=11,no_u)
1227+ write(6,'(i4,10(tr1,f9.4))')
1228+ & ik, (ebk(io,1,ik)/eV,io=1,min(10,2*no_u))
1229+ if ( 2*no_u > 10 ) write(6,'(4x,10(tr1,f9.4))')
1230+ & (ebk(io,1,ik)/eV,io=11,no_u*2)
1231+ end do
1232+
1233+ else
1234+ write(6,'(/,a,/,a4,a3,tr1,a9)')
1235+ & 'siesta: Band energies (eV):', 'ik', 'is', 'eps'
1236+ do ispin = 1, spin%spinor
1237+ do ik = 1,nbk
1238+ write(6,'(i4,i3,10(tr1,f9.4))')
1239+ & ik, ispin, (ebk(io,ispin,ik)/eV,io=1,min(10,no_u))
1240+ if ( no_u > 10 ) write(6,'(7x,10(tr1,f9.4))')
1241+ & (ebk(io,ispin,ik)/eV,io=11,no_u)
1242+ enddo
1243 enddo
1244- enddo
1245+ end if
1246 endif
1247+
1248 endif
1249 endif
1250
1251 ! Print eigenvalues
1252- if (IOnode .and. writeig) then
1253- if ((isolve.eq.SOLVE_DIAGON .or.
1254- & ((isolve.eq.SOLVE_MINIM) .and. minim_calc_eigenvalues))
1255- & .and. no_l.lt.1000) then
1256- if ( h_spin_dim <= 2 ) then
1257- write(6,'(/,a,/,a4,a3,a7)')
1258- & 'siesta: Eigenvalues (eV):', 'ik', 'is', 'eps'
1259- do ik = 1,nkpnt
1260- do ispin = 1,spinor_dim
1261- write(6,'(i4,i3,10f7.2)')
1262+ if ( IOnode .and. writeig .and. no_l < 1000 .and.
1263+ & (isolve.eq.SOLVE_DIAGON .or.
1264+ & (isolve.eq.SOLVE_MINIM .and. minim_calc_eigenvalues)) ) then
1265+
1266+ if ( spin%Grid == 4 ) then
1267+ write(6,'(/,a)') 'siesta: Eigenvalues (eV):'
1268+ do ik = 1,nkpnt
1269+ write(6,'(a,i6)') 'ik =', ik
1270+ write(6,'(10(tr1,f9.4))') (eo(io,1,ik)/eV,io=1,2*neigwanted)
1271+ end do
1272+
1273+ else
1274+ write(6,'(/,a,/,a4,a3,tr1,a9)')
1275+ & 'siesta: Eigenvalues (eV):', 'ik', 'is', 'eps'
1276+ do ik = 1,nkpnt
1277+ do ispin = 1, spin%spinor
1278+ write(6,'(i4,i3,10(tr1,f9.4))')
1279 & ik,ispin,(eo(io,ispin,ik)/eV,io=1,min(10,neigwanted))
1280- if (no_u.gt.10) write(6,'(7x,10f7.2)')
1281+ if (no_u.gt.10) write(6,'(7x,10(tr1,f9.4))')
1282 & (eo(io,ispin,ik)/eV,io=11,neigwanted)
1283- enddo
1284- enddo
1285- else
1286- write(6,'(/,a)') 'siesta: Eigenvalues (eV):'
1287- do ik = 1,nkpnt
1288- write(6,'(a,i6)') 'ik =', ik
1289- write(6,'(10f7.2)')
1290- & ((eo(io,ispin,ik)/eV,io=1,neigwanted),ispin=1,2)
1291- enddo
1292- endif
1293- write(6,'(a,f15.6,a)') 'siesta: Fermi energy =', ef/eV, ' eV'
1294- endif
1295+ end do
1296+ end do
1297+ end if
1298+ write(6,'(a,f15.6,a)') 'siesta: Fermi energy =', ef/eV, ' eV'
1299 endif
1300
1301 if (((isolve.eq.SOLVE_DIAGON).or.
1302 & ((isolve.eq.SOLVE_MINIM).and.minim_calc_eigenvalues))
1303 & .and.IOnode)
1304- & call ioeig(eo,ef,neigwanted,nspin,nkpnt,no_u,spinor_dim,
1305+ & call ioeig(eo,ef,neigwanted,spin%H,nkpnt,no_u,spin%spinor,
1306 & nkpnt,kpoint, kweight)
1307
1308
1309@@ -430,7 +460,7 @@
1310 ! Calculation of the bulk polarization using the Berry phase
1311 ! formulas by King-Smith and Vanderbilt
1312 if (nkpol.gt.0 .and. .not.bornz) then
1313- if (NonCol .or. SpOrb) then
1314+ if ( spin%NCol .or. spin%SO ) then
1315 if (IOnode) then
1316 write(6,'(/a)')
1317 . 'siesta_analysis: bulk polarization implemented only for'
1318@@ -439,7 +469,7 @@
1319 endif
1320 else
1321 call KSV_pol(na_u, na_s, xa_last, rmaxo, scell_last,
1322- & ucell_last,no_u, no_l, no_s, nspin, qspin,
1323+ & ucell_last,no_u, no_l, no_s, spin%Grid, qspin,
1324 & maxnh, nkpol, numh, listhptr, listh,
1325 & H, S, xijo, indxuo, isa, iphorb,
1326 & iaorb, lasto, shape,
1327@@ -449,7 +479,7 @@
1328
1329 ! Calculation of the optical conductivity
1330 call optical(na_u, na_s, xa_last, scell_last, ucell_last,
1331- & no_u, no_l, no_s, nspin, qspin,
1332+ & no_u, no_l, no_s, spin%Grid, qspin,
1333 & maxnh, numh, listhptr, listh, H, S, xijo,
1334 $ indxuo, ebk, ef, temp,
1335 & isa, iphorb, iphKB, lasto, lastkb, shape )
1336@@ -479,7 +509,7 @@
1337 g2max = g2cut
1338 dummy_str = 0.0
1339 dummy_strl = 0.0
1340- call dhscf( nspin, no_s, iaorb, iphorb, no_l,
1341+ call dhscf( spin%Grid, no_s, iaorb, iphorb, no_l,
1342 . no_u, na_u, na_s, isa, xa_last, indxua,
1343 & ntm, 0, 0, 0, filesOut,
1344 & maxnh, numh, listhptr, listh, Dscf, Datm,
1345
1346=== modified file 'Src/writewave.F'
1347--- Src/writewave.F 2018-10-17 13:04:40 +0000
1348+++ Src/writewave.F 2019-08-15 23:47:25 +0000
1349@@ -40,15 +40,23 @@
1350 USE alloc, only: re_alloc
1351 USE sys, only: die
1352 USE atomlist, only: no_u
1353+ USE m_spin, only: spin
1354
1355 implicit none
1356
1357+ integer :: max_n_states
1358+
1359 ! Find number of k-points for wavefunction printout
1360
1361 nullify(wfk)
1362
1363 nwk = 0
1364- call initwave( no_u, nwk, wfk )
1365+ if ( spin%Grid == 4 ) then
1366+ max_n_states = 2 * no_u
1367+ else
1368+ max_n_states = no_u
1369+ end if
1370+ call initwave( max_n_states, nwk, wfk )
1371
1372 if (nwk .eq. 0) then
1373 gamma_wavefunctions = .true.
1374@@ -96,7 +104,7 @@
1375 call die("WFS.BandMin < 1")
1376 endif
1377 if (wfs_band_max > norb) then
1378- call die("WFS.BandMax > number of orbitals")
1379+ call die("WFS.BandMax > maximum number of states")
1380 endif
1381 if (wfs_band_max < wfs_band_min) then
1382 call message("WARNING","WFS.BandMax < WFS.BandMin." //
1383@@ -126,7 +134,7 @@
1384 C Based on initband routine by J.Soler
1385 C Written by P. Ordejon, June 2003
1386 C **************************** INPUT **********************************
1387-C integer norb : Number of orbitals
1388+C integer norb : Number of orbitals (actually max number of bands)
1389 C *************************** OUTPUT **********************************
1390 C integer nk : Number k points to compute wavefunctions
1391 C real*8 kpoint(3,maxk) : k point vectors
1392@@ -383,7 +391,7 @@
1393
1394 end subroutine initwave
1395
1396- subroutine wwave( no, nspin, maxspn, maxo, maxuo, maxnh,
1397+ subroutine wwave( no, spin, maxo, maxuo, maxnh,
1398 . maxk,
1399 . numh, listhptr, listh, H, S, ef, xij, indxuo,
1400 . gamma, nk, kpoint, nuotot, occtol)
1401@@ -391,10 +399,10 @@
1402 C Finds wavefunctions at selected k-points.
1403 C Written by P. Ordejon, June 2003
1404 C from routine 'bands' written by J.M.Soler
1405+C Changed to use tSpin, N. Papior, August 2019
1406 C **************************** INPUT **********************************
1407 C integer no : Number of basis orbitals
1408-C integer nspin = h_spin_dim : Number of spin components of H, D
1409-C integer maxspn = spinor_dim : Second dimension of ek
1410+C tSpin spin : Contains spin information
1411 C integer maxo : First dimension of ek
1412 C integer maxuo : Second dimension of H and S
1413 C integer maxnh : Maximum number of orbitals interacting
1414@@ -406,7 +414,7 @@
1415 C hamiltonian matrix
1416 C integer listh(maxlh) : Nonzero hamiltonian-matrix element
1417 C column indexes for each matrix row
1418-C real*8 H(maxnh,nspin) : Hamiltonian in sparse form
1419+C real*8 H(maxnh,spin%H) : Hamiltonian in sparse form
1420 C real*8 S(maxnh) : Overlap in sparse form
1421 C real*8 ef : Fermi energy
1422 C real*8 xij(3,maxnh) : Vectors between orbital centers (sparse)
1423@@ -438,7 +446,7 @@
1424 use atmfuncs, only : symfio, cnfigfio, labelfis, nofis
1425 use atomlist, only : iaorb, iphorb
1426 use siesta_geom, only : isa
1427- use m_spin, only : NoMagn, SPpol, NonCol, SpOrb
1428+ use t_spin, only: tSpin
1429 use units, only : eV
1430
1431 #ifdef MPI
1432@@ -449,12 +457,12 @@
1433
1434 implicit none
1435
1436+ type(tSpin), intent(in) :: spin
1437 logical, intent(in) :: Gamma
1438 integer maxk, maxnh, maxo, maxuo, nk, no,
1439- . h_spin_dim, spinor_dim, nspin, maxspn,
1440 . nuotot, indxuo(no), listh(maxnh), numh(*),
1441 . listhptr(*)
1442- real(dp) ef, H(:,:), kpoint(3,maxk),
1443+ real(dp) ef, H(maxnh,spin%H), kpoint(3,maxk),
1444 . S(maxnh), xij(3,maxnh), occtol
1445
1446 external io_assign, io_close, memory
1447@@ -480,9 +488,7 @@
1448 data Dnew, Enew, e1, e2, qk, qtot, temp, wk /8*0.d0/
1449
1450 logical :: SaveParallelOverK
1451-
1452- h_spin_dim=size(H,dim=2)
1453-
1454+
1455
1456 C Get local number of orbitals
1457 #ifdef MPI
1458@@ -505,26 +511,17 @@
1459 endif
1460
1461 C Check spin
1462- if (h_spin_dim .gt. 2) then
1463- if (Node.eq.0) then
1464- write(6,'(/,a,/,a)')
1465- . 'writewave: WARNING: wavefunctions printed is only '
1466- write(6,'(/,a,/,a)')
1467- . ' implemented for nspin = 1 or 2'
1468- endif
1469- goto 999
1470- endif
1471
1472 C Allocate local arrays - only aux is relevant here
1473- if ( h_spin_dim >= 4 ) then
1474+ if ( spin%Grid == 4 ) then
1475 nhs = 2 * (2*nuotot) * (2*nuo)
1476 else
1477 nhs = 2 * nuotot * nuo
1478 endif
1479 call allocDenseMatrix(nhs, nhs, nhs)
1480
1481- allocate(ek(nuotot,maxspn,nk))
1482- call memory('A','D',maxspn*nk*nuotot,'writewave')
1483+ allocate(ek(nuotot,spin%spinor,nk))
1484+ call memory('A','D',nuotot*spin%spinor*nk,'writewave')
1485 naux = 2*nuotot*5
1486 allocate(aux(naux))
1487 call memory('A','D',naux,'writewave')
1488@@ -543,12 +540,12 @@
1489 write(6,'(a)') 'writewave: Wave Functions Coefficients'
1490 write(6,*)
1491 write(6,'(a26,2x,i6)') 'Number of k-points = ', nk
1492- write(6,'(a26,2x,i6)') 'Number of Spins = ', maxspn
1493+ write(6,'(a26,2x,i6)') 'Number of Spins = ', spin%Grid
1494 write(6,'(a26,2x,i6)') 'Number of basis orbs = ',nuotot
1495 write(6,*)
1496 endif
1497 write(iu) nk, gamma
1498- write(iu) maxspn
1499+ write(iu) spin%Grid ! This will be 1, 2, or 4
1500 write(iu) nuotot
1501 write(iu) (iaorb(j),labelfis(isa(iaorb(j))),
1502 . iphorb(j), cnfigfio(isa(iaorb(j)),iphorb(j)),
1503@@ -566,9 +563,9 @@
1504
1505 C Call appropriate diagonalization routine
1506
1507- if (NoMagn .or. SPpol) then
1508+ if ( spin%Grid <= 2 ) then
1509 if (gamma) then
1510- call diagg( h_spin_dim, nuo, maxuo, maxnh, maxnh,
1511+ call diagg( spin%H, nuo, maxuo, maxnh, maxnh,
1512 . maxo, numh, listhptr, listh, numh, listhptr,
1513 . listh, H, S, getD, getPSI,
1514 . fixspin, qtot, qs, temp,
1515@@ -588,7 +585,7 @@
1516 call diag_init()
1517 end if
1518
1519- call diagk( h_spin_dim, nuo, no, maxspn, maxnh, maxnh,
1520+ call diagk( spin%H, nuo, no, spin%spinor, maxnh, maxnh,
1521 . maxo, numh, listhptr, listh, numh, listhptr,
1522 . listh, H, S, getD, getPSI,
1523 . fixspin, qtot, qs, temp,
1524@@ -602,16 +599,16 @@
1525
1526 endif
1527
1528- elseif (NonCol) then
1529+ elseif ( spin%NCol) then
1530 if (gamma) then
1531- call diag2g( nuo, no, maxuo, maxnh, maxnh, maxo, numh,
1532+ call diag2g( nuo, no, maxnh, maxnh, maxo, numh,
1533 . listhptr, listh, numh, listhptr, listh,
1534 . H, S, getD, getPSI, qtot, temp, e1, e2, ek, qk,
1535 . Dnew, Enew, ef, Entropy,
1536 . Haux, Saux, psi, aux,
1537 . nuotot, occtol, 1, nuotot )
1538 else
1539- call diag2k( nuo, no, maxuo, maxnh, maxnh, maxo, numh,
1540+ call diag2k( nuo, no, maxnh, maxnh, maxo, numh,
1541 . listhptr, listh, numh, listhptr, listh,
1542 . H, S, getD, getPSI, qtot, temp, e1, e2, xij,
1543 . indxuo, nk, kpoint, wk, ek, qk, Dnew,
1544@@ -619,18 +616,18 @@
1545 . Haux, Saux, psi, Haux, Saux, aux,
1546 . nuotot, occtol, 1, nuotot )
1547 endif
1548- elseif (SpOrb) then
1549+ elseif ( spin%SO ) then
1550 if (gamma) then
1551 call diag3g( nuo, no, maxnh, maxnh, maxo, numh,
1552 . listhptr, listh, numh, listhptr, listh,
1553- . H, S, getD, qtot, temp, e1, e2, ek, qk,
1554+ . H, S, getD, getPSI, qtot, temp, e1, e2, ek, qk,
1555 . Dnew, Enew, ef, Entropy,
1556 . Haux, Saux, psi, aux,
1557 . nuotot, occtol, 1, nuotot )
1558 else
1559- call diag3k( nuo, no, maxuo, maxnh, maxnh, maxo, numh,
1560+ call diag3k( nuo, no, maxnh, maxnh, maxo, numh,
1561 . listhptr, listh, numh, listhptr, listh,
1562- . H, S, getD, qtot, temp, e1, e2, xij,
1563+ . H, S, getD, getPsi, qtot, temp, e1, e2, xij,
1564 . indxuo, nk, kpoint, wk, ek, qk, Dnew,
1565 . Enew, ef, Entropy,
1566 . Haux, Saux, psi, Haux, Saux, aux,
1567@@ -653,15 +650,16 @@
1568 end subroutine wwave
1569
1570
1571- subroutine writew(nuotot,nuo,ik,k,ispin,eo,psi,gamma)
1572+ subroutine writew(nuotot,nuo,ik,k,ispin,eo,psi,
1573+ $ gamma,non_coll,blocksize)
1574
1575 use precision
1576 use sys
1577 use parallel, only : Node, Nodes
1578+ use parallel, only : Module_Blocksize=>BlockSize
1579 use parallelsubs, only : GlobalToLocalOrb, WhichNodeOrb
1580 use units, only : eV
1581 use kpoint_grid, only : kweight
1582-
1583 #ifdef MPI
1584 use mpi_siesta
1585 #endif
1586@@ -673,16 +671,17 @@
1587 #endif
1588
1589 integer, intent(in) :: nuotot, nuo, ispin, ik
1590- real(dp), intent(in) :: eo(*), psi(*), k(3)
1591+ logical, intent(in) :: non_coll, gamma
1592+ real(dp), intent(in) :: eo(*), k(3)
1593+ real(dp), intent(in) :: psi(:)
1594+ integer, intent(in) :: blocksize
1595
1596- logical gamma
1597
1598 C Internal variables .............................................
1599 integer BNode, iie, iw, indwf, j, ind, iu
1600-
1601+ integer :: blocksize_saved
1602 integer number_of_wfns
1603 integer, allocatable :: ind_wfn(:)
1604-
1605 real(dp) :: kpoint_weight
1606 real(SP), dimension(:,:), allocatable :: aux !! NOTE SP
1607
1608@@ -692,12 +691,17 @@
1609
1610 C Allocate auxiliary arrays
1611
1612- if (gamma) then
1613- allocate(aux(1,nuotot))
1614- call memory('A','D',nuotot,'writewave')
1615+ if (non_coll) then
1616+ allocate(aux(4,nuotot))
1617+ call memory('A','D',4*nuotot,'writewave')
1618 else
1619- allocate(aux(2,nuotot))
1620- call memory('A','D',2*nuotot,'writewave')
1621+ if (gamma) then
1622+ allocate(aux(1,nuotot))
1623+ call memory('A','D',nuotot,'writewave')
1624+ else
1625+ allocate(aux(2,nuotot))
1626+ call memory('A','D',2*nuotot,'writewave')
1627+ endif
1628 endif
1629
1630 C Find file name, and open for Node 0
1631@@ -733,7 +737,11 @@
1632 if (wwf) then
1633 write(6,*)
1634 write(6,'(a22,2x,i6,2x,3f10.6)') 'k-point = ',ik, k(1:3)
1635- write(6,'(a22,2x,i6)') 'Spin component = ',ispin
1636+ if (non_coll) then
1637+ write(6,'(a22,2x,i6)') 'Spin component (non-collinear)= ',0
1638+ else
1639+ write(6,'(a22,2x,i6)') 'Spin component = ',ispin
1640+ endif
1641 write(6,'(a22,2x,i6)') 'Num. wavefunctions = ',nwflist(ik)
1642 write(6,'(a)') 'Use readwfsx utility to print '
1643 $ // "wavefunction coefficients from WFSX file"
1644@@ -748,14 +756,26 @@
1645 write(iu) nwflist(ik)
1646 endif
1647
1648-C Loop over wavefunctions that should be printed
1649-
1650+ ! Loop over wavefunctions that should be stored
1651+
1652+ ! The effective blocksize to use is passed as an argument.
1653+ ! Module_blocksize is the variable in the 'parallel' module that
1654+ ! holds the value that all the helper functions (WhichNodeOrb,
1655+ ! GetNodeOrb, etc) see. Hence, we must temporarily set
1656+ ! Module_blocksize to the passed blocksize.
1657+
1658+ ! Examples: non-collinear calculations need a wf blocksize double
1659+ ! the 'orbital' one
1660+
1661+ blocksize_saved = Module_blocksize
1662+ Module_blocksize = blocksize
1663+
1664 if (Node .eq. 0 .and. debug) then
1665 print *, " -*- Will print ", nwflist(ik), " wfns."
1666 print *, " -*- ", iwf(ik,1:nwflist(ik))
1667 endif
1668 do iw = 1,nwflist(ik)
1669- indwf = iwf(ik,iw)
1670+ indwf = iwf(ik,iw)
1671
1672 ! Determine which node handles this wavefunction
1673 ! Note that the distribution is block cyclic,
1674@@ -770,30 +790,44 @@
1675
1676 if (Node.eq.BNode) then
1677
1678-C Determine the index of the wavefunction in the local node
1679-
1680+ ! Determine the index of the wavefunction in the local node
1681 call GlobalToLocalOrb( indwf, BNode, Nodes, iie)
1682
1683-C Save wavefunction in aux array
1684-
1685-C psi has different structure in diagk and diagg, so the indexing
1686-C must be handled differently
1687-
1688- if (gamma) then
1689- do j = 1,nuotot
1690- ind = j + (iie-1)*nuotot
1691- aux(1,j) = real(psi(ind),kind=sp)
1692- enddo
1693- else
1694- do j = 1,nuotot
1695- ind = 1+(j-1)*2+(iie-1)*2*nuotot
1696- aux(1,j) = real(psi(ind),kind=sp)
1697- aux(2,j) = real(psi(ind+1),kind=sp)
1698- enddo
1699- endif
1700-
1701- endif
1702-
1703+ ! Save wavefunction in aux array
1704+
1705+ ! Despite being passed as a one-dimensional array, psi has
1706+ ! different underlying structures for different cases, so the
1707+ ! indexing must be handled differently
1708+
1709+ if (.not. non_coll) then
1710+ if (gamma) then
1711+ ! Real functions
1712+ do j = 1,nuotot
1713+ ind = j + (iie-1)*nuotot
1714+ aux(1,j) = real(psi(ind),kind=sp)
1715+ enddo
1716+ else
1717+ ! Complex functions: two reals per orbital coefficient
1718+ do j = 1,nuotot
1719+ ind = 1+(j-1)*2+(iie-1)*2*nuotot
1720+ aux(1,j) = real(psi(ind),kind=sp)
1721+ aux(2,j) = real(psi(ind+1),kind=sp)
1722+ enddo
1723+ endif
1724+ else ! non-collinear case, including SOC
1725+ ! Each 'orbital' coefficient is actually four reals: complex up/down
1726+ ! (spinor)
1727+ do j = 1,nuotot
1728+ ind = 1 + (j-1)*4 + (iie-1)*4*nuotot
1729+ aux(1,j) = real(psi(ind),kind=sp)
1730+ aux(2,j) = real(psi(ind+1),kind=sp)
1731+ aux(3,j) = real(psi(ind+2),kind=sp)
1732+ aux(4,j) = real(psi(ind+3),kind=sp)
1733+ enddo
1734+ endif ! non-coll or not
1735+
1736+ endif ! Node == BNode
1737+
1738 #ifdef MPI
1739 C Pass the wf to the master node
1740 if (BNode.ne.0) then
1741@@ -815,19 +849,22 @@
1742 C eigenvector is now stored in aux in Node 0, and can be printed
1743
1744 if (Node .eq. 0) then
1745- write(iu) indwf
1746- write(iu) eo(indwf)/eV
1747- write(iu) (aux(1:,j), j=1,nuotot)
1748- endif
1749+ write(iu) indwf
1750+ write(iu) eo(indwf)/eV
1751+ write(iu) (aux(1:,j), j=1,nuotot)
1752+ endif
1753
1754 enddo
1755-
1756+
1757 C Close output file
1758
1759 if (Node .eq. 0) then
1760 call io_close(iu)
1761 endif
1762
1763+ ! Restore blocksize value in module
1764+ Module_blocksize = blocksize_saved
1765+
1766 C Deallocate auxiliary arrays
1767
1768 call memory('D','D',size(aux),'writewave')
1769
1770=== added file 'Tests/Pseudos/Bi.psf'
1771--- Tests/Pseudos/Bi.psf 1970-01-01 00:00:00 +0000
1772+++ Tests/Pseudos/Bi.psf 2019-08-15 23:47:25 +0000
1773@@ -0,0 +1,3061 @@
1774+ Bi pb rel pcec
1775+ ATM3.3 12-FEB-13 Troullier-Martins
1776+ 6s 2.00r r= 1.98/6p 3.00r r= 1.98/5d10.00r r= 1.48/5f 0.00r r= 2.47/
1777+ 4 3 1216 0.298644840562E-04 0.125000000000E-01 15.0000000000
1778+ Radial grid follows
1779+ 0.375648965487E-06 0.756023013283E-06 0.114118157761E-05 0.153118484027E-05
1780+ 0.192609374007E-05 0.232596998233E-05 0.273087604852E-05 0.314087520605E-05
1781+ 0.355603151811E-05 0.397640985372E-05 0.440207589786E-05 0.483309616171E-05
1782+ 0.526953799306E-05 0.571146958683E-05 0.615895999574E-05 0.661207914108E-05
1783+ 0.707089782362E-05 0.753548773473E-05 0.800592146753E-05 0.848227252823E-05
1784+ 0.896461534767E-05 0.945302529289E-05 0.994757867894E-05 0.104483527808E-04
1785+ 0.109554258454E-04 0.114688771040E-04 0.119887867844E-04 0.125152361234E-04
1786+ 0.130483073800E-04 0.135880838476E-04 0.141346498673E-04 0.146880908412E-04
1787+ 0.152484932455E-04 0.158159446444E-04 0.163905337031E-04 0.169723502025E-04
1788+ 0.175614850526E-04 0.181580303068E-04 0.187620791765E-04 0.193737260458E-04
1789+ 0.199930664855E-04 0.206201972689E-04 0.212552163865E-04 0.218982230613E-04
1790+ 0.225493177644E-04 0.232086022306E-04 0.238761794746E-04 0.245521538066E-04
1791+ 0.252366308489E-04 0.259297175526E-04 0.266315222138E-04 0.273421544909E-04
1792+ 0.280617254217E-04 0.287903474405E-04 0.295281343961E-04 0.302752015692E-04
1793+ 0.310316656905E-04 0.317976449591E-04 0.325732590608E-04 0.333586291869E-04
1794+ 0.341538780531E-04 0.349591299186E-04 0.357745106057E-04 0.366001475192E-04
1795+ 0.374361696666E-04 0.382827076782E-04 0.391398938270E-04 0.400078620503E-04
1796+ 0.408867479698E-04 0.417766889133E-04 0.426778239358E-04 0.435902938416E-04
1797+ 0.445142412058E-04 0.454498103971E-04 0.463971476002E-04 0.473564008384E-04
1798+ 0.483277199970E-04 0.493112568465E-04 0.503071650667E-04 0.513156002701E-04
1799+ 0.523367200269E-04 0.533706838890E-04 0.544176534155E-04 0.554777921974E-04
1800+ 0.565512658836E-04 0.576382422066E-04 0.587388910086E-04 0.598533842682E-04
1801+ 0.609818961272E-04 0.621246029180E-04 0.632816831908E-04 0.644533177417E-04
1802+ 0.656396896410E-04 0.668409842618E-04 0.680573893087E-04 0.692890948476E-04
1803+ 0.705362933350E-04 0.717991796480E-04 0.730779511154E-04 0.743728075476E-04
1804+ 0.756839512688E-04 0.770115871477E-04 0.783559226302E-04 0.797171677714E-04
1805+ 0.810955352687E-04 0.824912404947E-04 0.839045015313E-04 0.853355392033E-04
1806+ 0.867845771134E-04 0.882518416766E-04 0.897375621560E-04 0.912419706984E-04
1807+ 0.927653023708E-04 0.943077951968E-04 0.958696901941E-04 0.974512314119E-04
1808+ 0.990526659693E-04 0.100674244094E-03 0.102316219160E-03 0.103978847730E-03
1809+ 0.105662389593E-03 0.107367107805E-03 0.109093268733E-03 0.110841142093E-03
1810+ 0.112611000993E-03 0.114403121978E-03 0.116217785069E-03 0.118055273812E-03
1811+ 0.119915875318E-03 0.121799880310E-03 0.123707583168E-03 0.125639281974E-03
1812+ 0.127595278559E-03 0.129575878553E-03 0.131581391427E-03 0.133612130549E-03
1813+ 0.135668413223E-03 0.137750560750E-03 0.139858898469E-03 0.141993755811E-03
1814+ 0.144155466353E-03 0.146344367867E-03 0.148560802372E-03 0.150805116190E-03
1815+ 0.153077660002E-03 0.155378788896E-03 0.157708862428E-03 0.160068244677E-03
1816+ 0.162457304301E-03 0.164876414596E-03 0.167325953553E-03 0.169806303917E-03
1817+ 0.172317853247E-03 0.174860993980E-03 0.177436123484E-03 0.180043644130E-03
1818+ 0.182683963349E-03 0.185357493695E-03 0.188064652912E-03 0.190805864001E-03
1819+ 0.193581555280E-03 0.196392160458E-03 0.199238118697E-03 0.202119874683E-03
1820+ 0.205037878698E-03 0.207992586685E-03 0.210984460323E-03 0.214013967098E-03
1821+ 0.217081580378E-03 0.220187779482E-03 0.223333049762E-03 0.226517882671E-03
1822+ 0.229742775847E-03 0.233008233185E-03 0.236314764920E-03 0.239662887705E-03
1823+ 0.243053124689E-03 0.246486005606E-03 0.249962066848E-03 0.253481851558E-03
1824+ 0.257045909710E-03 0.260654798195E-03 0.264309080908E-03 0.268009328839E-03
1825+ 0.271756120160E-03 0.275550040314E-03 0.279391682109E-03 0.283281645808E-03
1826+ 0.287220539228E-03 0.291208977828E-03 0.295247584809E-03 0.299336991212E-03
1827+ 0.303477836016E-03 0.307670766236E-03 0.311916437025E-03 0.316215511778E-03
1828+ 0.320568662235E-03 0.324976568584E-03 0.329439919569E-03 0.333959412598E-03
1829+ 0.338535753852E-03 0.343169658392E-03 0.347861850275E-03 0.352613062667E-03
1830+ 0.357424037954E-03 0.362295527861E-03 0.367228293567E-03 0.372223105827E-03
1831+ 0.377280745092E-03 0.382402001627E-03 0.387587675638E-03 0.392838577400E-03
1832+ 0.398155527374E-03 0.403539356347E-03 0.408990905551E-03 0.414511026802E-03
1833+ 0.420100582631E-03 0.425760446418E-03 0.431491502526E-03 0.437294646446E-03
1834+ 0.443170784931E-03 0.449120836139E-03 0.455145729778E-03 0.461246407249E-03
1835+ 0.467423821797E-03 0.473678938654E-03 0.480012735195E-03 0.486426201089E-03
1836+ 0.492920338453E-03 0.499496162009E-03 0.506154699243E-03 0.512896990565E-03
1837+ 0.519724089472E-03 0.526637062711E-03 0.533636990449E-03 0.540724966439E-03
1838+ 0.547902098192E-03 0.555169507149E-03 0.562528328857E-03 0.569979713147E-03
1839+ 0.577524824313E-03 0.585164841295E-03 0.592900957860E-03 0.600734382792E-03
1840+ 0.608666340081E-03 0.616698069109E-03 0.624830824852E-03 0.633065878069E-03
1841+ 0.641404515504E-03 0.649848040086E-03 0.658397771132E-03 0.667055044556E-03
1842+ 0.675821213075E-03 0.684697646419E-03 0.693685731550E-03 0.702786872874E-03
1843+ 0.712002492463E-03 0.721334030277E-03 0.730782944387E-03 0.740350711205E-03
1844+ 0.750038825715E-03 0.759848801703E-03 0.769782171999E-03 0.779840488712E-03
1845+ 0.790025323474E-03 0.800338267687E-03 0.810780932768E-03 0.821354950407E-03
1846+ 0.832061972814E-03 0.842903672983E-03 0.853881744952E-03 0.864997904068E-03
1847+ 0.876253887253E-03 0.887651453276E-03 0.899192383032E-03 0.910878479813E-03
1848+ 0.922711569596E-03 0.934693501326E-03 0.946826147203E-03 0.959111402979E-03
1849+ 0.971551188249E-03 0.984147446755E-03 0.996902146688E-03 0.100981728100E-02
1850+ 0.102289486770E-02 0.103613695019E-02 0.104954559757E-02 0.106312290497E-02
1851+ 0.107687099388E-02 0.109079201246E-02 0.110488813589E-02 0.111916156673E-02
1852+ 0.113361453523E-02 0.114824929969E-02 0.116306814683E-02 0.117807339212E-02
1853+ 0.119326738016E-02 0.120865248504E-02 0.122423111072E-02 0.124000569139E-02
1854+ 0.125597869185E-02 0.127215260793E-02 0.128852996683E-02 0.130511332754E-02
1855+ 0.132190528125E-02 0.133890845174E-02 0.135612549578E-02 0.137355910358E-02
1856+ 0.139121199916E-02 0.140908694084E-02 0.142718672161E-02 0.144551416959E-02
1857+ 0.146407214849E-02 0.148286355803E-02 0.150189133440E-02 0.152115845074E-02
1858+ 0.154066791756E-02 0.156042278327E-02 0.158042613459E-02 0.160068109711E-02
1859+ 0.162119083569E-02 0.164195855502E-02 0.166298750010E-02 0.168428095675E-02
1860+ 0.170584225211E-02 0.172767475518E-02 0.174978187733E-02 0.177216707284E-02
1861+ 0.179483383946E-02 0.181778571889E-02 0.184102629744E-02 0.186455920647E-02
1862+ 0.188838812306E-02 0.191251677052E-02 0.193694891900E-02 0.196168838608E-02
1863+ 0.198673903735E-02 0.201210478702E-02 0.203778959855E-02 0.206379748523E-02
1864+ 0.209013251085E-02 0.211679879032E-02 0.214380049029E-02 0.217114182983E-02
1865+ 0.219882708109E-02 0.222686056994E-02 0.225524667668E-02 0.228398983668E-02
1866+ 0.231309454112E-02 0.234256533768E-02 0.237240683123E-02 0.240262368455E-02
1867+ 0.243322061911E-02 0.246420241572E-02 0.249557391535E-02 0.252734001988E-02
1868+ 0.255950569281E-02 0.259207596010E-02 0.262505591092E-02 0.265845069845E-02
1869+ 0.269226554070E-02 0.272650572131E-02 0.276117659036E-02 0.279628356527E-02
1870+ 0.283183213155E-02 0.286782784376E-02 0.290427632628E-02 0.294118327428E-02
1871+ 0.297855445453E-02 0.301639570636E-02 0.305471294255E-02 0.309351215023E-02
1872+ 0.313279939187E-02 0.317258080617E-02 0.321286260907E-02 0.325365109467E-02
1873+ 0.329495263626E-02 0.333677368729E-02 0.337912078238E-02 0.342200053836E-02
1874+ 0.346541965526E-02 0.350938491743E-02 0.355390319452E-02 0.359898144260E-02
1875+ 0.364462670523E-02 0.369084611459E-02 0.373764689256E-02 0.378503635184E-02
1876+ 0.383302189713E-02 0.388161102629E-02 0.393081133144E-02 0.398063050026E-02
1877+ 0.403107631707E-02 0.408215666415E-02 0.413387952290E-02 0.418625297511E-02
1878+ 0.423928520426E-02 0.429298449674E-02 0.434735924316E-02 0.440241793970E-02
1879+ 0.445816918938E-02 0.451462170345E-02 0.457178430274E-02 0.462966591901E-02
1880+ 0.468827559639E-02 0.474762249275E-02 0.480771588117E-02 0.486856515137E-02
1881+ 0.493017981117E-02 0.499256948797E-02 0.505574393031E-02 0.511971300930E-02
1882+ 0.518448672026E-02 0.525007518420E-02 0.531648864945E-02 0.538373749326E-02
1883+ 0.545183222339E-02 0.552078347979E-02 0.559060203622E-02 0.566129880198E-02
1884+ 0.573288482358E-02 0.580537128649E-02 0.587876951686E-02 0.595309098331E-02
1885+ 0.602834729873E-02 0.610455022206E-02 0.618171166017E-02 0.625984366969E-02
1886+ 0.633895845891E-02 0.641906838967E-02 0.650018597931E-02 0.658232390262E-02
1887+ 0.666549499382E-02 0.674971224856E-02 0.683498882595E-02 0.692133805065E-02
1888+ 0.700877341488E-02 0.709730858060E-02 0.718695738162E-02 0.727773382573E-02
1889+ 0.736965209695E-02 0.746272655769E-02 0.755697175102E-02 0.765240240295E-02
1890+ 0.774903342471E-02 0.784687991510E-02 0.794595716282E-02 0.804628064890E-02
1891+ 0.814786604909E-02 0.825072923632E-02 0.835488628316E-02 0.846035346436E-02
1892+ 0.856714725940E-02 0.867528435500E-02 0.878478164783E-02 0.889565624705E-02
1893+ 0.900792547704E-02 0.912160688010E-02 0.923671821918E-02 0.935327748066E-02
1894+ 0.947130287716E-02 0.959081285039E-02 0.971182607403E-02 0.983436145664E-02
1895+ 0.995843814462E-02 0.100840755252E-01 0.102112932295E-01 0.103401111355E-01
1896+ 0.104705493713E-01 0.106026283182E-01 0.107363686136E-01 0.108717911549E-01
1897+ 0.110089171021E-01 0.111477678813E-01 0.112883651884E-01 0.114307309919E-01
1898+ 0.115748875367E-01 0.117208573476E-01 0.118686632327E-01 0.120183282870E-01
1899+ 0.121698758960E-01 0.123233297391E-01 0.124787137940E-01 0.126360523398E-01
1900+ 0.127953699607E-01 0.129566915507E-01 0.131200423165E-01 0.132854477819E-01
1901+ 0.134529337920E-01 0.136225265167E-01 0.137942524554E-01 0.139681384404E-01
1902+ 0.141442116418E-01 0.143224995715E-01 0.145030300873E-01 0.146858313974E-01
1903+ 0.148709320649E-01 0.150583610122E-01 0.152481475255E-01 0.154403212592E-01
1904+ 0.156349122409E-01 0.158319508758E-01 0.160314679516E-01 0.162334946434E-01
1905+ 0.164380625180E-01 0.166452035398E-01 0.168549500749E-01 0.170673348966E-01
1906+ 0.172823911905E-01 0.175001525595E-01 0.177206530294E-01 0.179439270538E-01
1907+ 0.181700095197E-01 0.183989357529E-01 0.186307415236E-01 0.188654630520E-01
1908+ 0.191031370137E-01 0.193438005459E-01 0.195874912526E-01 0.198342472111E-01
1909+ 0.200841069775E-01 0.203371095928E-01 0.205932945893E-01 0.208527019963E-01
1910+ 0.211153723468E-01 0.213813466836E-01 0.216506665657E-01 0.219233740749E-01
1911+ 0.221995118222E-01 0.224791229549E-01 0.227622511626E-01 0.230489406848E-01
1912+ 0.233392363172E-01 0.236331834192E-01 0.239308279205E-01 0.242322163288E-01
1913+ 0.245373957366E-01 0.248464138288E-01 0.251593188901E-01 0.254761598125E-01
1914+ 0.257969861031E-01 0.261218478916E-01 0.264507959385E-01 0.267838816424E-01
1915+ 0.271211570486E-01 0.274626748573E-01 0.278084884311E-01 0.281586518042E-01
1916+ 0.285132196903E-01 0.288722474915E-01 0.292357913064E-01 0.296039079395E-01
1917+ 0.299766549099E-01 0.303540904600E-01 0.307362735649E-01 0.311232639414E-01
1918+ 0.315151220577E-01 0.319119091422E-01 0.323136871939E-01 0.327205189914E-01
1919+ 0.331324681028E-01 0.335495988963E-01 0.339719765491E-01 0.343996670589E-01
1920+ 0.348327372530E-01 0.352712547995E-01 0.357152882177E-01 0.361649068888E-01
1921+ 0.366201810665E-01 0.370811818885E-01 0.375479813869E-01 0.380206525002E-01
1922+ 0.384992690841E-01 0.389839059236E-01 0.394746387441E-01 0.399715442236E-01
1923+ 0.404747000046E-01 0.409841847062E-01 0.415000779364E-01 0.420224603046E-01
1924+ 0.425514134342E-01 0.430870199750E-01 0.436293636168E-01 0.441785291017E-01
1925+ 0.447346022381E-01 0.452976699135E-01 0.458678201084E-01 0.464451419099E-01
1926+ 0.470297255257E-01 0.476216622981E-01 0.482210447186E-01 0.488279664418E-01
1927+ 0.494425223005E-01 0.500648083202E-01 0.506949217345E-01 0.513329609999E-01
1928+ 0.519790258112E-01 0.526332171175E-01 0.532956371374E-01 0.539663893754E-01
1929+ 0.546455786380E-01 0.553333110498E-01 0.560296940703E-01 0.567348365110E-01
1930+ 0.574488485517E-01 0.581718417582E-01 0.589039290998E-01 0.596452249665E-01
1931+ 0.603958451873E-01 0.611559070482E-01 0.619255293104E-01 0.627048322290E-01
1932+ 0.634939375715E-01 0.642929686373E-01 0.651020502767E-01 0.659213089102E-01
1933+ 0.667508725488E-01 0.675908708135E-01 0.684414349555E-01 0.693026978775E-01
1934+ 0.701747941533E-01 0.710578600499E-01 0.719520335481E-01 0.728574543643E-01
1935+ 0.737742639724E-01 0.747026056256E-01 0.756426243794E-01 0.765944671136E-01
1936+ 0.775582825554E-01 0.785342213031E-01 0.795224358490E-01 0.805230806036E-01
1937+ 0.815363119199E-01 0.825622881171E-01 0.836011695063E-01 0.846531184146E-01
1938+ 0.857182992113E-01 0.867968783331E-01 0.878890243100E-01 0.889949077922E-01
1939+ 0.901147015762E-01 0.912485806321E-01 0.923967221306E-01 0.935593054714E-01
1940+ 0.947365123105E-01 0.959285265887E-01 0.971355345607E-01 0.983577248240E-01
1941+ 0.995952883483E-01 0.100848418505 0.102117311100 0.103402164398
1942+ 0.104703179161 0.106020558675 0.107354508783 0.108705237919
1943+ 0.110072957135 0.111457880141 0.112860223334 0.114280205834
1944+ 0.115718049514 0.117173979041 0.118648221907 0.120141008466
1945+ 0.121652571968 0.123183148598 0.124732977512 0.126302300874
1946+ 0.127891363894 0.129500414866 0.131129705208 0.132779489500
1947+ 0.134450025523 0.136141574302 0.137854400146 0.139588770687
1948+ 0.141344956924 0.143123233264 0.144923877567 0.146747171187
1949+ 0.148593399018 0.150462849535 0.152355814846 0.154272590729
1950+ 0.156213476684 0.158178775980 0.160168795697 0.162183846781
1951+ 0.164224244087 0.166290306432 0.168382356643 0.170500721605
1952+ 0.172645732318 0.174817723945 0.177017035863 0.179244011719
1953+ 0.181498999484 0.183782351502 0.186094424554 0.188435579904
1954+ 0.190806183363 0.193206605343 0.195637220915 0.198098409867
1955+ 0.200590556764 0.203114051011 0.205669286908 0.208256663716
1956+ 0.210876585717 0.213529462281 0.216215707923 0.218935742377
1957+ 0.221689990652 0.224478883105 0.227302855507 0.230162349109
1958+ 0.233057810713 0.235989692740 0.238958453303 0.241964556277
1959+ 0.245008471372 0.248090674205 0.251211646377 0.254371875547
1960+ 0.257571855505 0.260812086257 0.264093074094 0.267415331678
1961+ 0.270779378118 0.274185739052 0.277634946733 0.281127540106
1962+ 0.284664064895 0.288245073689 0.291871126029 0.295542788493
1963+ 0.299260634785 0.303025245827 0.306837209846 0.310697122470
1964+ 0.314605586818 0.318563213595 0.322570621189 0.326628435765
1965+ 0.330737291365 0.334897830006 0.339110701781 0.343376564959
1966+ 0.347696086090 0.352069940109 0.356498810439 0.360983389099
1967+ 0.365524376815 0.370122483124 0.374778426491 0.379492934417
1968+ 0.384266743551 0.389100599812 0.393995258501 0.398951484416
1969+ 0.403970051979 0.409051745350 0.414197358556 0.419407695608
1970+ 0.424683570631 0.430025807994 0.435435242430 0.440912719175
1971+ 0.446459094095 0.452075233824 0.457762015895 0.463520328878
1972+ 0.469351072522 0.475255157892 0.481233507514 0.487287055517
1973+ 0.493416747780 0.499623542080 0.505908408242 0.512272328288
1974+ 0.518716296594 0.525241320043 0.531848418183 0.538538623387
1975+ 0.545312981013 0.552172549568 0.559118400874 0.566151620234
1976+ 0.573273306602 0.580484572758 0.587786545476 0.595180365703
1977+ 0.602667188740 0.610248184418 0.617924537282 0.625697446779
1978+ 0.633568127441 0.641537809079 0.649607736971 0.657779172060
1979+ 0.666053391149 0.674431687102 0.682915369045 0.691505762570
1980+ 0.700204209943 0.709012070315 0.717930719932 0.726961552352
1981+ 0.736105978659 0.745365427689 0.754741346250 0.764235199349
1982+ 0.773848470418 0.783582661552 0.793439293738 0.803419907093
1983+ 0.813526061110 0.823759334896 0.834121327420 0.844613657765
1984+ 0.855237965379 0.865995910331 0.876889173573 0.887919457198
1985+ 0.899088484711 0.910398001296 0.921849774087 0.933445592447
1986+ 0.945187268246 0.957076636146 0.969115553883 0.981305902564
1987+ 0.993649586955 1.00614853578 1.01880470203 1.03162006325
1988+ 1.04459662188 1.05773640551 1.07104146728 1.08451388612
1989+ 1.09815576714 1.11196924189 1.12595646876 1.14011963329
1990+ 1.15446094849 1.16898265524 1.18368702257 1.19857634807
1991+ 1.21365295823 1.22891920880 1.24437748517 1.26003020271
1992+ 1.27587980720 1.29192877518 1.30817961432 1.32463486385
1993+ 1.34129709495 1.35816891111 1.37525294859 1.39255187681
1994+ 1.41006839876 1.42780525143 1.44576520624 1.46395106948
1995+ 1.48236568271 1.50101192327 1.51989270465 1.53901097703
1996+ 1.55836972768 1.57797198143 1.59782080118 1.61791928835
1997+ 1.63827058336 1.65887786615 1.67974435665 1.70087331529
1998+ 1.72226804351 1.74393188429 1.76586822263 1.78808048615
1999+ 1.81057214554 1.83334671519 1.85640775365 1.87975886427
2000+ 1.90340369570 1.92734594250 1.95158934569 1.97613769335
2001+ 2.00099482121 2.02616461325 2.05165100230 2.07745797066
2002+ 2.10358955072 2.13004982559 2.15684292975 2.18397304967
2003+ 2.21144442449 2.23926134667 2.26742816266 2.29594927357
2004+ 2.32482913590 2.35407226217 2.38368322170 2.41366664124
2005+ 2.44402720577 2.47476965919 2.50589880507 2.53741950740
2006+ 2.56933669136 2.60165534408 2.63438051540 2.66751731870
2007+ 2.70107093167 2.73504659715 2.76944962388 2.80428538742
2008+ 2.83955933092 2.87527696601 2.91144387364 2.94806570496
2009+ 2.98514818222 3.02269709962 3.06071832426 3.09921779703
2010+ 3.13820153355 3.17767562512 3.21764623963 3.25811962258
2011+ 3.29910209801 3.34060006953 3.38262002127 3.42516851894
2012+ 3.46825221082 3.51187782883 3.55605218957 3.60078219536
2013+ 3.64607483536 3.69193718664 3.73837641528 3.78539977751
2014+ 3.83301462082 3.88122838514 3.93004860395 3.97948290551
2015+ 4.02953901404 4.08022475091 4.13154803587 4.18351688827
2016+ 4.23613942837 4.28942387854 4.34337856458 4.39801191703
2017+ 4.45333247245 4.50934887480 4.56606987675 4.62350434107
2018+ 4.68166124202 4.74054966673 4.80017881664 4.86055800892
2019+ 4.92169667795 4.98360437676 5.04629077856 5.10976567822
2020+ 5.17403899384 5.23912076824 5.30502117059 5.37175049796
2021+ 5.43931917693 5.50773776526 5.57701695349 5.64716756663
2022+ 5.71820056586 5.79012705022 5.86295825839 5.93670557037
2023+ 6.01138050935 6.08699474343 6.16356008749 6.24108850501
2024+ 6.31959210998 6.39908316875 6.47957410194 6.56107748643
2025+ 6.64360605730 6.72717270979 6.81179050138 6.89747265375
2026+ 6.98423255493 7.07208376132 7.16103999985 7.25111517012
2027+ 7.34232334655 7.43467878061 7.52819590302 7.62288932603
2028+ 7.71877384566 7.81586444408 7.91417629189 8.01372475051
2029+ 8.11452537459 8.21659391444 8.31994631847 8.42459873571
2030+ 8.53056751830 8.63786922409 8.74652061919 8.85653868060
2031+ 8.96794059886 9.08074378075 9.19496585200 9.31062466004
2032+ 9.42773827678 9.54632500149 9.66640336356 9.78799212549
2033+ 9.91111028577 10.0357770819 10.1620119932 10.2898347443
2034+ 10.4192653076 10.5503239070 10.6830310207 10.8174073843
2035+ 10.9534739945 11.0912521120 11.2307632649 11.3720292520
2036+ 11.5150721466 11.6599142992 11.8065783418 11.9550871910
2037+ 12.1054640515 12.2577324201 12.4119160890 12.5680391497
2038+ 12.7261259968 12.8862013316 13.0482901662 13.2124178274
2039+ 13.3786099605 13.5468925332 13.7172918401 13.8898345064
2040+ 14.0645474923 14.2414580970 14.4205939632 14.6019830812
2041+ 14.7856537934 14.9716347988 15.1599551573 15.3506442942
2042+ 15.5437320053 15.7392484607 15.9372242104 16.1376901885
2043+ 16.3406777181 16.5462185166 16.7543447000 16.9650887886
2044+ 17.1784837114 17.3945628120 17.6133598530 17.8349090221
2045+ 18.0592449366 18.2864026495 18.5164176548 18.7493258926
2046+ 18.9851637554 19.2239680933 19.4657762201 19.7106259186
2047+ 19.9585554472 20.2096035454 20.4638094399 20.7212128509
2048+ 20.9818539982 21.2457736076 21.5130129171 21.7836136832
2049+ 22.0576181879 22.3350692450 22.6160102069 22.9004849709
2050+ 23.1885379870 23.4802142641 23.7755593770 24.0746194741
2051+ 24.3774412842 24.6840721237 24.9945599044 25.3089531406
2052+ 25.6273009569 25.9496530957 26.2760599253 26.6065724474
2053+ 26.9412423053 27.2801217917 27.6232638573 27.9707221188
2054+ 28.3225508672 28.6788050764 29.0395404119 29.4048132394
2055+ 29.7746806335 30.1492003866 30.5284310183 30.9124317841
2056+ 31.3012626850 31.6949844765 32.0936586784 32.4973475845
2057+ 32.9061142720 33.3200226114 33.7391372768 34.1635237557
2058+ 34.5932483594 35.0283782331 35.4689813669 35.9151266059
2059+ 36.3668836611 36.8243231206 37.2875164601 37.7565360547
2060+ 38.2314551894 38.7123480715 39.1992898414 39.6923565847
2061+ 40.1916253442 40.6971741316 41.2090819399 41.7274287558
2062+ 42.2522955719 42.7837643999 43.3219182828 43.8668413082
2063+ 44.4186186215 44.9773364390 45.5430820614 46.1159438878
2064+ 46.6960114289 47.2833753214 47.8781273423 48.4803604225
2065+ 49.0901686624 49.7076473457 50.3328929547 50.9660031853
2066+ 51.6070769622 52.2562144546 52.9135170915 53.5790875777
2067+ 54.2530299100 54.9354493933 55.6264526570 56.3261476718
2068+ 57.0346437664 57.7520516448 58.4784834034 59.2140525488
2069+ 59.9588740149 60.7130641818 61.4767408931 62.2500234750
2070+ 63.0330327543 63.8258910779 64.6287223315 65.4416519592
2071+ 66.2648069827 67.0983160219 67.9423093140 68.7969187350
2072+ 69.6622778191 70.5385217805 71.4257875341 72.3242137170
2073+ 73.2339407101 74.1551106601 75.0878675017 76.0323569800
2074+ 76.9887266734 77.9571260167 78.9377063242 79.9306208136
2075+ 80.9360246297 81.9540748691 82.9849306040 84.0287529079
2076+ 85.0857048800 86.1559516713 87.2396605100 88.3370007278
2077+ 89.4481437863 90.5732633040 91.7125350830 92.8661371368
2078+ 94.0342497182 95.2170553471 96.4147388393 97.6274873352
2079+ 98.8554903293 100.098939700 101.358029738 102.632957179
2080+ 103.923921233 105.231123615 106.554768580 107.895062949
2081+ 109.252216145 110.626440227 112.017949920 113.426962651
2082+ 114.853698579 116.298380637 117.761234558 119.242488916
2083+ Down Pseudopotential follows (l on next line)
2084+ 0
2085+ -0.344168687199E-05 -0.692679840936E-05 -0.104554786075E-04 -0.140289478131E-04
2086+ -0.176469065595E-04 -0.213107567387E-04 -0.250204576271E-04 -0.287769247868E-04
2087+ -0.325806108655E-04 -0.364321472444E-04 -0.403321296066E-04 -0.442811671561E-04
2088+ -0.482798785096E-04 -0.523288870839E-04 -0.564288249121E-04 -0.605803351020E-04
2089+ -0.647840642146E-04 -0.690406688999E-04 -0.733508169255E-04 -0.777151789328E-04
2090+ -0.821344370388E-04 -0.866092832973E-04 -0.911404171782E-04 -0.957285444134E-04
2091+ -0.100374383087E-03 -0.105078660462E-03 -0.109842108281E-03 -0.114665475116E-03
2092+ -0.119549512171E-03 -0.124494981798E-03 -0.129502657329E-03 -0.134573322717E-03
2093+ -0.139707770074E-03 -0.144906798902E-03 -0.150171224552E-03 -0.155501868603E-03
2094+ -0.160899563188E-03 -0.166365152228E-03 -0.171899491848E-03 -0.177503443427E-03
2095+ -0.183177883715E-03 -0.188923699707E-03 -0.194741789671E-03 -0.200633063791E-03
2096+ -0.206598437413E-03 -0.212638847878E-03 -0.218755239624E-03 -0.224948563469E-03
2097+ -0.231219789284E-03 -0.237569898767E-03 -0.243999884013E-03 -0.250510745727E-03
2098+ -0.257103505071E-03 -0.263779192527E-03 -0.270538847013E-03 -0.277383530413E-03
2099+ -0.284314307686E-03 -0.291332263400E-03 -0.298438495416E-03 -0.305634110901E-03
2100+ -0.312920236998E-03 -0.320298011876E-03 -0.327768587213E-03 -0.335333130229E-03
2101+ -0.342992825129E-03 -0.350748865287E-03 -0.358602464327E-03 -0.366554852417E-03
2102+ -0.374607266828E-03 -0.382760967092E-03 -0.391017229999E-03 -0.399377344966E-03
2103+ -0.407842615531E-03 -0.416414364742E-03 -0.425093936433E-03 -0.433882682943E-03
2104+ -0.442781975768E-03 -0.451793210712E-03 -0.460917792987E-03 -0.470157145969E-03
2105+ -0.479512717321E-03 -0.488985968172E-03 -0.498578376470E-03 -0.508291441805E-03
2106+ -0.518126684904E-03 -0.528085638490E-03 -0.538169859579E-03 -0.548380926392E-03
2107+ -0.558720431066E-03 -0.569189991536E-03 -0.579791242488E-03 -0.590525841147E-03
2108+ -0.601395464919E-03 -0.612401810050E-03 -0.623546599492E-03 -0.634831572710E-03
2109+ -0.646258492993E-03 -0.657829147133E-03 -0.669545340929E-03 -0.681408907375E-03
2110+ -0.693421699779E-03 -0.705585592158E-03 -0.717902488767E-03 -0.730374313785E-03
2111+ -0.743003014199E-03 -0.755790564062E-03 -0.768738961224E-03 -0.781850230270E-03
2112+ -0.795126417336E-03 -0.808569598877E-03 -0.822181876116E-03 -0.835965373103E-03
2113+ -0.849922245115E-03 -0.864054673918E-03 -0.878364867097E-03 -0.892855059288E-03
2114+ -0.907527515729E-03 -0.922384529582E-03 -0.937428421625E-03 -0.952661542551E-03
2115+ -0.968086271856E-03 -0.983705021111E-03 -0.999520230194E-03 -0.101553436936E-02
2116+ -0.103174994242E-02 -0.104816948220E-02 -0.106479555412E-02 -0.108163075600E-02
2117+ -0.109867771954E-02 -0.111593910674E-02 -0.113341761563E-02 -0.115111597786E-02
2118+ -0.116903695686E-02 -0.118718335562E-02 -0.120555800661E-02 -0.122416378234E-02
2119+ -0.124300359171E-02 -0.126208037470E-02 -0.128139711482E-02 -0.130095683031E-02
2120+ -0.132076257612E-02 -0.134081744734E-02 -0.136112457800E-02 -0.138168714216E-02
2121+ -0.140250835038E-02 -0.142359145705E-02 -0.144493975754E-02 -0.146655658590E-02
2122+ -0.148844532051E-02 -0.151060938240E-02 -0.153305223304E-02 -0.155577738053E-02
2123+ -0.157878837581E-02 -0.160208881254E-02 -0.162568233360E-02 -0.164957262462E-02
2124+ -0.167376341905E-02 -0.169825849540E-02 -0.172306168210E-02 -0.174817685571E-02
2125+ -0.177360793793E-02 -0.179935890471E-02 -0.182543377914E-02 -0.185183663442E-02
2126+ -0.187857159765E-02 -0.190564284529E-02 -0.193305460649E-02 -0.196081116681E-02
2127+ -0.198891686110E-02 -0.201737608151E-02 -0.204619327567E-02 -0.207537294460E-02
2128+ -0.210491964952E-02 -0.213483800646E-02 -0.216513268980E-02 -0.219580843389E-02
2129+ -0.222687003166E-02 -0.225832233589E-02 -0.229017026197E-02 -0.232241878590E-02
2130+ -0.235507294657E-02 -0.238813784596E-02 -0.242161865126E-02 -0.245552059364E-02
2131+ -0.248984896921E-02 -0.252460914425E-02 -0.255980654798E-02 -0.259544668067E-02
2132+ -0.263153511248E-02 -0.266807747986E-02 -0.270507949465E-02 -0.274254693828E-02
2133+ -0.278048566374E-02 -0.281890160054E-02 -0.285780075085E-02 -0.289718919271E-02
2134+ -0.293707308036E-02 -0.297745864603E-02 -0.301835220049E-02 -0.305976013253E-02
2135+ -0.310168891261E-02 -0.314414509310E-02 -0.318713530681E-02 -0.323066627127E-02
2136+ -0.327474478879E-02 -0.331937774578E-02 -0.336457211763E-02 -0.341033496529E-02
2137+ -0.345667343898E-02 -0.350359478007E-02 -0.355110631966E-02 -0.359921548145E-02
2138+ -0.364792978309E-02 -0.369725683598E-02 -0.374720434733E-02 -0.379778012281E-02
2139+ -0.384899206375E-02 -0.390084817209E-02 -0.395335655179E-02 -0.400652540639E-02
2140+ -0.406036304381E-02 -0.411487787704E-02 -0.417007842325E-02 -0.422597330795E-02
2141+ -0.428257126561E-02 -0.433988113901E-02 -0.439791188309E-02 -0.445667256572E-02
2142+ -0.451617236864E-02 -0.457642058816E-02 -0.463742663840E-02 -0.469920005260E-02
2143+ -0.476175048225E-02 -0.482508770102E-02 -0.488922160617E-02 -0.495416221868E-02
2144+ -0.501991968523E-02 -0.508650428109E-02 -0.515392641063E-02 -0.522219660830E-02
2145+ -0.529132554178E-02 -0.536132401262E-02 -0.543220295856E-02 -0.550397345475E-02
2146+ -0.557664671513E-02 -0.565023409580E-02 -0.572474709487E-02 -0.580019735488E-02
2147+ -0.587659666606E-02 -0.595395696545E-02 -0.603229034113E-02 -0.611160903342E-02
2148+ -0.619192543528E-02 -0.627325209739E-02 -0.635560172752E-02 -0.643898719207E-02
2149+ -0.652342152155E-02 -0.660891790876E-02 -0.669548971258E-02 -0.678315046118E-02
2150+ -0.687191385112E-02 -0.696179375249E-02 -0.705280420957E-02 -0.714495944286E-02
2151+ -0.723827385261E-02 -0.733276201933E-02 -0.742843870724E-02 -0.752531886677E-02
2152+ -0.762341763553E-02 -0.772275034225E-02 -0.782333250835E-02 -0.792517985007E-02
2153+ -0.802830828179E-02 -0.813273391813E-02 -0.823847307625E-02 -0.834554227819E-02
2154+ -0.845395825439E-02 -0.856373794583E-02 -0.867489850587E-02 -0.878745730443E-02
2155+ -0.890143192960E-02 -0.901684019035E-02 -0.913370012038E-02 -0.925202997978E-02
2156+ -0.937184825856E-02 -0.949317367915E-02 -0.961602519960E-02 -0.974042201633E-02
2157+ -0.986638356739E-02 -0.999392953552E-02 -0.101230798505E-01 -0.102538546932E-01
2158+ -0.103862744986E-01 -0.105203599580E-01 -0.106561320239E-01 -0.107936119118E-01
2159+ -0.109328211039E-01 -0.110737813534E-01 -0.112165146865E-01 -0.113610434064E-01
2160+ -0.115073900977E-01 -0.116555776284E-01 -0.118056291541E-01 -0.119575681221E-01
2161+ -0.121114182747E-01 -0.122672036526E-01 -0.124249485988E-01 -0.125846777631E-01
2162+ -0.127464161050E-01 -0.129101888979E-01 -0.130760217336E-01 -0.132439405254E-01
2163+ -0.134139715126E-01 -0.135861412653E-01 -0.137604766867E-01 -0.139370050196E-01
2164+ -0.141157538490E-01 -0.142967511066E-01 -0.144800250762E-01 -0.146656043970E-01
2165+ -0.148535180687E-01 -0.150437954557E-01 -0.152364662917E-01 -0.154315606851E-01
2166+ -0.156291091222E-01 -0.158291424736E-01 -0.160316919980E-01 -0.162367893472E-01
2167+ -0.164444665716E-01 -0.166547561246E-01 -0.168676908680E-01 -0.170833040770E-01
2168+ -0.173016294453E-01 -0.175227010909E-01 -0.177465535609E-01 -0.179732218369E-01
2169+ -0.182027413410E-01 -0.184351479405E-01 -0.186704779543E-01 -0.189087681585E-01
2170+ -0.191500557914E-01 -0.193943785603E-01 -0.196417746466E-01 -0.198922827123E-01
2171+ -0.201459419062E-01 -0.204027918690E-01 -0.206628727408E-01 -0.209262251666E-01
2172+ -0.211928903026E-01 -0.214629098235E-01 -0.217363259277E-01 -0.220131813450E-01
2173+ -0.222935193430E-01 -0.225773837335E-01 -0.228648188798E-01 -0.231558697034E-01
2174+ -0.234505816912E-01 -0.237490009025E-01 -0.240511739760E-01 -0.243571481378E-01
2175+ -0.246669712081E-01 -0.249806916087E-01 -0.252983583713E-01 -0.256200211442E-01
2176+ -0.259457302009E-01 -0.262755364476E-01 -0.266094914309E-01 -0.269476473466E-01
2177+ -0.272900570471E-01 -0.276367740504E-01 -0.279878525477E-01 -0.283433474127E-01
2178+ -0.287033142096E-01 -0.290678092021E-01 -0.294368893620E-01 -0.298106123784E-01
2179+ -0.301890366666E-01 -0.305722213773E-01 -0.309602264055E-01 -0.313531124008E-01
2180+ -0.317509407757E-01 -0.321537737164E-01 -0.325616741917E-01 -0.329747059631E-01
2181+ -0.333929335954E-01 -0.338164224657E-01 -0.342452387746E-01 -0.346794495561E-01
2182+ -0.351191226886E-01 -0.355643269047E-01 -0.360151318030E-01 -0.364716078582E-01
2183+ -0.369338264326E-01 -0.374018597873E-01 -0.378757810933E-01 -0.383556644432E-01
2184+ -0.388415848627E-01 -0.393336183227E-01 -0.398318417505E-01 -0.403363330428E-01
2185+ -0.408471710774E-01 -0.413644357256E-01 -0.418882078650E-01 -0.424185693919E-01
2186+ -0.429556032346E-01 -0.434993933658E-01 -0.440500248167E-01 -0.446075836893E-01
2187+ -0.451721571710E-01 -0.457438335476E-01 -0.463227022174E-01 -0.469088537054E-01
2188+ -0.475023796773E-01 -0.481033729543E-01 -0.487119275273E-01 -0.493281385719E-01
2189+ -0.499521024637E-01 -0.505839167927E-01 -0.512236803796E-01 -0.518714932908E-01
2190+ -0.525274568542E-01 -0.531916736753E-01 -0.538642476538E-01 -0.545452839991E-01
2191+ -0.552348892476E-01 -0.559331712794E-01 -0.566402393351E-01 -0.573562040333E-01
2192+ -0.580811773879E-01 -0.588152728261E-01 -0.595586052059E-01 -0.603112908345E-01
2193+ -0.610734474870E-01 -0.618451944242E-01 -0.626266524125E-01 -0.634179437422E-01
2194+ -0.642191922474E-01 -0.650305233253E-01 -0.658520639562E-01 -0.666839427236E-01
2195+ -0.675262898348E-01 -0.683792371411E-01 -0.692429181594E-01 -0.701174680925E-01
2196+ -0.710030238516E-01 -0.718997240773E-01 -0.728077091620E-01 -0.737271212719E-01
2197+ -0.746581043702E-01 -0.756008042395E-01 -0.765553685052E-01 -0.775219466590E-01
2198+ -0.785006900830E-01 -0.794917520732E-01 -0.804952878649E-01 -0.815114546564E-01
2199+ -0.825404116352E-01 -0.835823200026E-01 -0.846373430000E-01 -0.857056459349E-01
2200+ -0.867873962071E-01 -0.878827633359E-01 -0.889919189872E-01 -0.901150370009E-01
2201+ -0.912522934190E-01 -0.924038665135E-01 -0.935699368157E-01 -0.947506871447E-01
2202+ -0.959463026370E-01 -0.971569707764E-01 -0.983828814243E-01 -0.996242268501E-01
2203+ -0.100881201762 -0.102154003341 -0.103442831266 -0.104747887757
2204+ -0.106069377596 -0.107407508169 -0.108762489496 -0.110134534266
2205+ -0.111523857870 -0.112930678438 -0.114355216875 -0.115797696895
2206+ -0.117258345058 -0.118737390808 -0.120235066511 -0.121751607491
2207+ -0.123287252070 -0.124842241607 -0.126416820539 -0.128011236417
2208+ -0.129625739953 -0.131260585056 -0.132916028877 -0.134592331850
2209+ -0.136289757737 -0.138008573670 -0.139749050195 -0.141511461321
2210+ -0.143296084559 -0.145103200976 -0.146933095237 -0.148786055652
2211+ -0.150662374229 -0.152562346719 -0.154486272668 -0.156434455467
2212+ -0.158407202404 -0.160404824712 -0.162427637628 -0.164475960444
2213+ -0.166550116560 -0.168650433540 -0.170777243170 -0.172930881512
2214+ -0.175111688963 -0.177320010316 -0.179556194816 -0.181820596220
2215+ -0.184113572863 -0.186435487718 -0.188786708455 -0.191167607514
2216+ -0.193578562163 -0.196019954566 -0.198492171854 -0.200995606188
2217+ -0.203530654832 -0.206097720225 -0.208697210048 -0.211329537301
2218+ -0.213995120374 -0.216694383128 -0.219427754963 -0.222195670903
2219+ -0.224998571674 -0.227836903780 -0.230711119590 -0.233621677419
2220+ -0.236569041612 -0.239553682630 -0.242576077140 -0.245636708102
2221+ -0.248736064857 -0.251874643224 -0.255052945593 -0.258271481015
2222+ -0.261530765306 -0.264831321141 -0.268173678157 -0.271558373054
2223+ -0.274985949700 -0.278456959238 -0.281971960190 -0.285531518572
2224+ -0.289136208003 -0.292786609821 -0.296483313199 -0.300226915260
2225+ -0.304018021203 -0.307857244423 -0.311745206638 -0.315682538015
2226+ -0.319669877300 -0.323707871956 -0.327797178291 -0.331938461602
2227+ -0.336132396313 -0.340379666122 -0.344680964143 -0.349036993060
2228+ -0.353448465277 -0.357916103076 -0.362440638776 -0.367022814894
2229+ -0.371663384312 -0.376363110447 -0.381122767425 -0.385943140255
2230+ -0.390825025013 -0.395769229022 -0.400776571049 -0.405847881487
2231+ -0.410984002564 -0.416185788534 -0.421454105891 -0.426789833574
2232+ -0.432193863189 -0.437667099224 -0.443210459276 -0.448824874287
2233+ -0.454511288773 -0.460270661071 -0.466103963587 -0.472012183046
2234+ -0.477996320756 -0.484057392872 -0.490196430670 -0.496414480825
2235+ -0.502712605700 -0.509091883635 -0.515553409252 -0.522098293762
2236+ -0.528727665281 -0.535442669156 -0.542244468293 -0.549134243505
2237+ -0.556113193856 -0.563182537024 -0.570343509669 -0.577597367811
2238+ -0.584945387217 -0.592388863802 -0.599929114041 -0.607567475384
2239+ -0.615305306690 -0.623143988675 -0.631084924364 -0.639129539560
2240+ -0.647279283329 -0.655535628489 -0.663900072128 -0.672374136119
2241+ -0.680959367663 -0.689657339842 -0.698469652187 -0.707397931265
2242+ -0.716443831281 -0.725609034700 -0.734895252882 -0.744304226741
2243+ -0.753837727420 -0.763497556990 -0.773285549162 -0.783203570028
2244+ -0.793253518819 -0.803437328691 -0.813756967525 -0.824214438764
2245+ -0.834811782265 -0.845551075180 -0.856434432865 -0.867464009815
2246+ -0.878642000631 -0.889970641011 -0.901452208776 -0.913089024927
2247+ -0.924883454731 -0.936837908845 -0.948954844477 -0.961236766571
2248+ -0.973686229046 -0.986305836060 -0.999098243319 -1.01206615943
2249+ -1.02521234728 -1.03853962550 -1.05205086991 -1.06574901507
2250+ -1.07963705584 -1.09371804903 -1.10799511505 -1.12247143963
2251+ -1.13715027564 -1.15203494491 -1.16712884011 -1.18243542675
2252+ -1.19795824513 -1.21370091251 -1.22966712518 -1.24586066070
2253+ -1.26228538022 -1.27894523077 -1.29584424774 -1.31298655736
2254+ -1.33037637928 -1.34801802927 -1.36591592189 -1.38407457340
2255+ -1.40249860462 -1.42119274396 -1.44016183048 -1.45941081716
2256+ -1.47894477410 -1.49876889194 -1.51888848536 -1.53930899664
2257+ -1.56003599940 -1.58107520235 -1.60243245323 -1.62411374287
2258+ -1.64612520928 -1.66847314195 -1.69116398623 -1.71420434781
2259+ -1.73760099741 -1.76136087545 -1.78549109705 -1.80999895693
2260+ -1.83489193468 -1.86017769997 -1.88586411799 -1.91195925505
2261+ -1.93847138425 -1.96540899136 -1.99278078075 -2.02059568159
2262+ -2.04886285410 -2.07759169597 -2.10679184890 -2.13647320537
2263+ -2.16664591544 -2.19732039378 -2.22850732681 -2.26021767994
2264+ -2.29246270505 -2.32525394800 -2.35860325636 -2.39252278717
2265+ -2.42702501497 -2.46212273977 -2.49782909535 -2.53415755743
2266+ -2.57112195219 -2.60873646467 -2.64701564744 -2.68597442919
2267+ -2.72562812354 -2.76599243779 -2.80708348181 -2.84891777686
2268+ -2.89151226458 -2.93488431585 -2.97905173969 -3.02403279220
2269+ -3.06984618532 -3.11651109565 -3.16404717314 -3.21247454964
2270+ -3.26181384737 -3.31208618720 -3.36331319673 -3.41551701821
2271+ -3.46872031616 -3.52294628471 -3.57821865466 -3.63456170020
2272+ -3.69200024513 -3.75055966881 -3.81026591149 -3.87114547925
2273+ -3.93322544825 -3.99653346845 -4.06109776666 -4.12694714885
2274+ -4.19411100170 -4.26261929334 -4.33250257322 -4.40379197100
2275+ -4.47651919457 -4.55071652687 -4.62641682179 -4.70365349879
2276+ -4.78246053642 -4.86287246459 -4.94492435553 -5.02865181354
2277+ -5.11409096334 -5.20127843717 -5.29025136051 -5.38104733656
2278+ -5.47370442940 -5.56826114602 -5.66475641720 -5.76322957738
2279+ -5.86372034375 -5.96626879460 -6.07091534726 -6.17770073588
2280+ -6.28666598936 -6.39785240976 -6.51130155164 -6.62705520293
2281+ -6.74515536764 -6.86564425127 -6.98856424948 -7.11395794080
2282+ -7.24186808425 -7.37233762281 -7.50540969370 -7.64112764658
2283+ -7.77953507092 -7.92067583371 -8.06459412901 -8.21133454068
2284+ -8.36094211997 -8.51346247950 -8.66894190539 -8.82742748915
2285+ -8.98896728108 -9.15361046658 -9.32140756668 -9.49241066360
2286+ -9.66667365155 -9.84425251142 -10.0252056246 -10.2095939263
2287+ -10.3974823175 -10.5889348994 -10.7840293936 -10.9828626984
2288+ -11.1853196453 -11.3921745678 -11.6014146806 -11.8102642499
2289+ -12.0221168165 -12.2393026908 -12.4612848983 -12.6884521500
2290+ -12.9209454725 -13.1589193608 -13.4025296562 -13.6519202652
2291+ -13.9072279100 -14.1685803710 -14.4360957615 -14.7098813807
2292+ -14.9900323702 -15.2766301735 -15.5697408098 -15.8694129709
2293+ -16.1756759491 -16.4885373999 -16.8079809489 -17.1339636438
2294+ -17.4664132738 -17.8052255636 -18.1502612474 -18.5013430814
2295+ -18.8582527990 -19.2207280440 -19.5884593430 -19.9610871550
2296+ -20.3381990609 -20.7193271547 -21.1039457167 -21.4914692423
2297+ -21.8812509020 -22.2725815555 -22.6646893867 -23.0567402679
2298+ -23.4478389742 -23.8370313261 -24.2233073996 -24.6056058837
2299+ -24.9828196743 -25.3538028593 -25.7173790806 -26.0723516897
2300+ -26.4175138431 -26.7516675473 -27.0736188969 -27.3822418944
2301+ -27.6764275575 -27.9551168402 -28.2174096239 -28.4624161308
2302+ -28.6893783236 -28.8977228152 -29.0870050447 -29.2569811613
2303+ -29.4076063318 -29.5390590615 -29.6517549196 -29.7463586359
2304+ -29.8237911770 -29.8852306873 -29.9321054028 -29.9660762971
2305+ -29.9890067262 -30.0029158517 -30.0099116235 -30.0121007544
2306+ -30.0114611539 -30.0097026191 -30.0080225717 -30.0069049966
2307+ -30.0060710840 -30.0053029068 -30.0046205298 -30.0040312326
2308+ -30.0035039851 -30.0030426788 -30.0026365663 -30.0022805302
2309+ -30.0019688109 -30.0016964272 -30.0014588623 -30.0012520615
2310+ -30.0010723889 -30.0007919083 -30.0005824716 -30.0004266961
2311+ -30.0003112940 -30.0002261473 -30.0001635825 -30.0001178034
2312+ -30.0000844500 -30.0000602557 -30.0000427842 -30.0000302250
2313+ -30.0000212399 -30.0000148431 -30.0000103117 -30.0000071190
2314+ -30.0000048815 -30.0000033227 -30.0000022433 -30.0000015006
2315+ -30.0000009936 -30.0000006497 -30.0000004188 -30.0000002651
2316+ -30.0000001639 -30.0000000983 -30.0000000563 -30.0000000300
2317+ -30.0000000140 -30.0000000045 -29.9999999993 -29.9999999966
2318+ -29.9999999955 -29.9999999953 -29.9999999956 -29.9999999961
2319+ -29.9999999966 -29.9999999972 -29.9999999977 -29.9999999982
2320+ -29.9999999985 -29.9999999989 -29.9999999991 -29.9999999993
2321+ -29.9999999995 -29.9999999996 -29.9999999997 -29.9999999998
2322+ -29.9999999998 -29.9999999999 -29.9999999999 -29.9999999999
2323+ -29.9999999999 -30.0000000000 -30.0000000000 -30.0000000000
2324+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
2325+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
2326+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
2327+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
2328+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
2329+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
2330+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
2331+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
2332+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
2333+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
2334+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
2335+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
2336+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
2337+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
2338+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
2339+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
2340+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
2341+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
2342+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
2343+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
2344+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
2345+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
2346+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
2347+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
2348+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
2349+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
2350+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
2351+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
2352+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
2353+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
2354+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
2355+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
2356+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
2357+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
2358+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
2359+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
2360+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
2361+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
2362+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
2363+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
2364+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
2365+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
2366+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
2367+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
2368+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
2369+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
2370+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
2371+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
2372+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
2373+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
2374+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
2375+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
2376+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
2377+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
2378+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
2379+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
2380+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
2381+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
2382+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
2383+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
2384+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
2385+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
2386+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
2387+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
2388+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
2389+ Down Pseudopotential follows (l on next line)
2390+ 1
2391+ -0.786726987868E-05 -0.158336314041E-04 -0.238999287762E-04 -0.320680913533E-04
2392+ -0.403385375993E-04 -0.487133963666E-04 -0.571933630364E-04 -0.657800985343E-04
2393+ -0.744748102476E-04 -0.832788937899E-04 -0.921937186901E-04 -0.101220677731E-03
2394+ -0.110361182966E-03 -0.119616661227E-03 -0.128988558068E-03 -0.138478340352E-03
2395+ -0.148087488755E-03 -0.157817504536E-03 -0.167669910693E-03 -0.177646243857E-03
2396+ -0.187748063028E-03 -0.197976948170E-03 -0.208334497833E-03 -0.218822328139E-03
2397+ -0.229442079013E-03 -0.240195411154E-03 -0.251084001479E-03 -0.262109555631E-03
2398+ -0.273273793914E-03 -0.284578459976E-03 -0.296025320787E-03 -0.307616166434E-03
2399+ -0.319352807822E-03 -0.331237076059E-03 -0.343270831077E-03 -0.355455952178E-03
2400+ -0.367794342520E-03 -0.380287930522E-03 -0.392938670449E-03 -0.405748535632E-03
2401+ -0.418719528758E-03 -0.431853676924E-03 -0.445153032842E-03 -0.458619675656E-03
2402+ -0.472255704380E-03 -0.486063254911E-03 -0.500044485317E-03 -0.514201575315E-03
2403+ -0.528536739129E-03 -0.543052218464E-03 -0.557750281272E-03 -0.572633220160E-03
2404+ -0.587703364445E-03 -0.602963069219E-03 -0.618414714668E-03 -0.634060720818E-03
2405+ -0.649903527853E-03 -0.665945612864E-03 -0.682189483749E-03 -0.698637675451E-03
2406+ -0.715292760847E-03 -0.732157342024E-03 -0.749234052993E-03 -0.766525561953E-03
2407+ -0.784034572967E-03 -0.801763818385E-03 -0.819716070163E-03 -0.837894136405E-03
2408+ -0.856300852166E-03 -0.874939094857E-03 -0.893811779500E-03 -0.912921854350E-03
2409+ -0.932272302646E-03 -0.951866148270E-03 -0.971706457279E-03 -0.991796325901E-03
2410+ -0.101213889145E-02 -0.103273733778E-02 -0.105359488061E-02 -0.107471477662E-02
2411+ -0.109610032984E-02 -0.111775488111E-02 -0.113968181171E-02 -0.116188454855E-02
2412+ -0.118436656387E-02 -0.120713136650E-02 -0.123018251438E-02 -0.125352361184E-02
2413+ -0.127715830262E-02 -0.130109028205E-02 -0.132532328834E-02 -0.134986110872E-02
2414+ -0.137470757737E-02 -0.139986657444E-02 -0.142534203426E-02 -0.145113793551E-02
2415+ -0.147725830883E-02 -0.150370723689E-02 -0.153048885025E-02 -0.155760733591E-02
2416+ -0.158506693080E-02 -0.161287192251E-02 -0.164102665927E-02 -0.166953553994E-02
2417+ -0.169840301733E-02 -0.172763360284E-02 -0.175723186358E-02 -0.178720242570E-02
2418+ -0.181754996965E-02 -0.184827923930E-02 -0.187939503688E-02 -0.191090222138E-02
2419+ -0.194280571745E-02 -0.197511051106E-02 -0.200782164925E-02 -0.204094424185E-02
2420+ -0.207448346545E-02 -0.210844456117E-02 -0.214283283485E-02 -0.217765365978E-02
2421+ -0.221291247608E-02 -0.224861479443E-02 -0.228476619280E-02 -0.232137231903E-02
2422+ -0.235843889447E-02 -0.239597170995E-02 -0.243397662988E-02 -0.247245959258E-02
2423+ -0.251142661225E-02 -0.255088377594E-02 -0.259083724983E-02 -0.263129327730E-02
2424+ -0.267225817775E-02 -0.271373835479E-02 -0.275574028687E-02 -0.279827053830E-02
2425+ -0.284133575623E-02 -0.288494266590E-02 -0.292909808371E-02 -0.297380890900E-02
2426+ -0.301908212662E-02 -0.306492481102E-02 -0.311134412561E-02 -0.315834732454E-02
2427+ -0.320594174977E-02 -0.325413483908E-02 -0.330293412379E-02 -0.335234722726E-02
2428+ -0.340238187107E-02 -0.345304587413E-02 -0.350434715105E-02 -0.355629371915E-02
2429+ -0.360889369526E-02 -0.366215529637E-02 -0.371608684688E-02 -0.377069677277E-02
2430+ -0.382599360753E-02 -0.388198599001E-02 -0.393868267019E-02 -0.399609250803E-02
2431+ -0.405422447136E-02 -0.411308764570E-02 -0.417269122798E-02 -0.423304453034E-02
2432+ -0.429415698470E-02 -0.435603813908E-02 -0.441869766175E-02 -0.448214534580E-02
2433+ -0.454639110288E-02 -0.461144497211E-02 -0.467731711911E-02 -0.474401783481E-02
2434+ -0.481155754316E-02 -0.487994679670E-02 -0.494919628094E-02 -0.501931681700E-02
2435+ -0.509031936114E-02 -0.516221500701E-02 -0.523501498935E-02 -0.530873068297E-02
2436+ -0.538337360614E-02 -0.545895542163E-02 -0.553548794000E-02 -0.561298311935E-02
2437+ -0.569145306729E-02 -0.577091004734E-02 -0.585136647267E-02 -0.593283491538E-02
2438+ -0.601532810637E-02 -0.609885893296E-02 -0.618344044900E-02 -0.626908587034E-02
2439+ -0.635580857788E-02 -0.644362212370E-02 -0.653254022846E-02 -0.662257678578E-02
2440+ -0.671374586374E-02 -0.680606170801E-02 -0.689953874356E-02 -0.699419157546E-02
2441+ -0.709003499379E-02 -0.718708397520E-02 -0.728535368272E-02 -0.738485947144E-02
2442+ -0.748561688982E-02 -0.758764168048E-02 -0.769094978641E-02 -0.779555734893E-02
2443+ -0.790148071287E-02 -0.800873642987E-02 -0.811734125839E-02 -0.822731216809E-02
2444+ -0.833866634263E-02 -0.845142118104E-02 -0.856559430122E-02 -0.868120354425E-02
2445+ -0.879826697305E-02 -0.891680287901E-02 -0.903682978492E-02 -0.915836644425E-02
2446+ -0.928143184752E-02 -0.940604522469E-02 -0.953222604599E-02 -0.965999402772E-02
2447+ -0.978936913468E-02 -0.992037158122E-02 -0.100530218369E-01 -0.101873406291E-01
2448+ -0.103233489455E-01 -0.104610680372E-01 -0.106005194232E-01 -0.107417248941E-01
2449+ -0.108847065126E-01 -0.110294866201E-01 -0.111760878394E-01 -0.113245330772E-01
2450+ -0.114748455279E-01 -0.116270486786E-01 -0.117811663119E-01 -0.119372225086E-01
2451+ -0.120952416529E-01 -0.122552484359E-01 -0.124172678591E-01 -0.125813252387E-01
2452+ -0.127474462085E-01 -0.129156567261E-01 -0.130859830747E-01 -0.132584518677E-01
2453+ -0.134330900549E-01 -0.136099249232E-01 -0.137889841038E-01 -0.139702955757E-01
2454+ -0.141538876685E-01 -0.143397890697E-01 -0.145280288272E-01 -0.147186363530E-01
2455+ -0.149116414313E-01 -0.151070742191E-01 -0.153049652533E-01 -0.155053454558E-01
2456+ -0.157082461358E-01 -0.159136989976E-01 -0.161217361440E-01 -0.163323900812E-01
2457+ -0.165456937250E-01 -0.167616804045E-01 -0.169803838685E-01 -0.172018382903E-01
2458+ -0.174260782727E-01 -0.176531388543E-01 -0.178830555140E-01 -0.181158641771E-01
2459+ -0.183516012208E-01 -0.185903034801E-01 -0.188320082532E-01 -0.190767533070E-01
2460+ -0.193245768841E-01 -0.195755177082E-01 -0.198296149894E-01 -0.200869084317E-01
2461+ -0.203474382383E-01 -0.206112451178E-01 -0.208783702913E-01 -0.211488554983E-01
2462+ -0.214227430034E-01 -0.217000756026E-01 -0.219808966303E-01 -0.222652499661E-01
2463+ -0.225531800416E-01 -0.228447318474E-01 -0.231399509396E-01 -0.234388834475E-01
2464+ -0.237415760811E-01 -0.240480761373E-01 -0.243584315086E-01 -0.246726906896E-01
2465+ -0.249909027845E-01 -0.253131175162E-01 -0.256393852321E-01 -0.259697569133E-01
2466+ -0.263042841826E-01 -0.266430193115E-01 -0.269860152291E-01 -0.273333255307E-01
2467+ -0.276850044858E-01 -0.280411070461E-01 -0.284016888548E-01 -0.287668062552E-01
2468+ -0.291365162992E-01 -0.295108767561E-01 -0.298899461225E-01 -0.302737836304E-01
2469+ -0.306624492569E-01 -0.310560037340E-01 -0.314545085570E-01 -0.318580259953E-01
2470+ -0.322666191016E-01 -0.326803517212E-01 -0.330992885033E-01 -0.335234949098E-01
2471+ -0.339530372265E-01 -0.343879825726E-01 -0.348283989119E-01 -0.352743550633E-01
2472+ -0.357259207109E-01 -0.361831664160E-01 -0.366461636272E-01 -0.371149846918E-01
2473+ -0.375897028676E-01 -0.380703923337E-01 -0.385571282023E-01 -0.390499865307E-01
2474+ -0.395490443328E-01 -0.400543795915E-01 -0.405660712706E-01 -0.410841993272E-01
2475+ -0.416088447247E-01 -0.421400894443E-01 -0.426780164991E-01 -0.432227099465E-01
2476+ -0.437742549009E-01 -0.443327375480E-01 -0.448982451573E-01 -0.454708660964E-01
2477+ -0.460506898448E-01 -0.466378070072E-01 -0.472323093285E-01 -0.478342897078E-01
2478+ -0.484438422127E-01 -0.490610620945E-01 -0.496860458026E-01 -0.503188909999E-01
2479+ -0.509596965780E-01 -0.516085626726E-01 -0.522655906793E-01 -0.529308832691E-01
2480+ -0.536045444051E-01 -0.542866793580E-01 -0.549773947230E-01 -0.556767984367E-01
2481+ -0.563849997934E-01 -0.571021094624E-01 -0.578282395057E-01 -0.585635033950E-01
2482+ -0.593080160296E-01 -0.600618937546E-01 -0.608252543789E-01 -0.615982171935E-01
2483+ -0.623809029905E-01 -0.631734340817E-01 -0.639759343180E-01 -0.647885291083E-01
2484+ -0.656113454397E-01 -0.664445118972E-01 -0.672881586834E-01 -0.681424176394E-01
2485+ -0.690074222652E-01 -0.698833077405E-01 -0.707702109462E-01 -0.716682704853E-01
2486+ -0.725776267051E-01 -0.734984217188E-01 -0.744307994279E-01 -0.753749055446E-01
2487+ -0.763308876150E-01 -0.772988950416E-01 -0.782790791069E-01 -0.792715929975E-01
2488+ -0.802765918275E-01 -0.812942326630E-01 -0.823246745469E-01 -0.833680785235E-01
2489+ -0.844246076635E-01 -0.854944270905E-01 -0.865777040056E-01 -0.876746077145E-01
2490+ -0.887853096537E-01 -0.899099834173E-01 -0.910488047840E-01 -0.922019517454E-01
2491+ -0.933696045327E-01 -0.945519456461E-01 -0.957491598827E-01 -0.969614343654E-01
2492+ -0.981889585728E-01 -0.994319243683E-01 -0.100690526030 -0.101964960283
2493+ -0.103255426327 -0.104562125870 -0.105885263159 -0.107225045013
2494+ -0.108581680854 -0.109955382740 -0.111346365400 -0.112754846265
2495+ -0.114181045504 -0.115625186058 -0.117087493677 -0.118568196949
2496+ -0.120067527344 -0.121585719246 -0.123123009988 -0.124679639895
2497+ -0.126255852316 -0.127851893665 -0.129468013459 -0.131104464359
2498+ -0.132761502205 -0.134439386062 -0.136138378257 -0.137858744421
2499+ -0.139600753531 -0.141364677952 -0.143150793478 -0.144959379382
2500+ -0.146790718451 -0.148645097035 -0.150522805094 -0.152424136239
2501+ -0.154349387781 -0.156298860778 -0.158272860081 -0.160271694382
2502+ -0.162295676263 -0.164345122247 -0.166420352845 -0.168521692608
2503+ -0.170649470176 -0.172804018335 -0.174985674062 -0.177194778585
2504+ -0.179431677434 -0.181696720493 -0.183990262059 -0.186312660897
2505+ -0.188664280296 -0.191045488124 -0.193456656892 -0.195898163807
2506+ -0.198370390835 -0.200873724759 -0.203408557242 -0.205975284889
2507+ -0.208574309309 -0.211206037177 -0.213870880301 -0.216569255687
2508+ -0.219301585601 -0.222068297643 -0.224869824808 -0.227706605557
2509+ -0.230579083890 -0.233487709410 -0.236432937398 -0.239415228888
2510+ -0.242435050734 -0.245492875687 -0.248589182473 -0.251724455864
2511+ -0.254899186761 -0.258113872263 -0.261369015759 -0.264665126995
2512+ -0.268002722164 -0.271382323987 -0.274804461791 -0.278269671602
2513+ -0.281778496222 -0.285331485322 -0.288929195529 -0.292572190509
2514+ -0.296261041067 -0.299996325230 -0.303778628344 -0.307608543167
2515+ -0.311486669963 -0.315413616600 -0.319389998647 -0.323416439471
2516+ -0.327493570341 -0.331622030528 -0.335802467406 -0.340035536559
2517+ -0.344321901886 -0.348662235708 -0.353057218876 -0.357507540882
2518+ -0.362013899971 -0.366577003253 -0.371197566820 -0.375876315858
2519+ -0.380613984768 -0.385411317285 -0.390269066600 -0.395187995479
2520+ -0.400168876392 -0.405212491635 -0.410319633463 -0.415491104213
2521+ -0.420727716442 -0.426030293056 -0.431399667445 -0.436836683624
2522+ -0.442342196367 -0.447917071353 -0.453562185302 -0.459278426128
2523+ -0.465066693080 -0.470927896893 -0.476862959938 -0.482872816377
2524+ -0.488958412319 -0.495120705975 -0.501360667820 -0.507679280753
2525+ -0.514077540265 -0.520556454604 -0.527117044943 -0.533760345557
2526+ -0.540487403989 -0.547299281235 -0.554197051920 -0.561181804481
2527+ -0.568254641350 -0.575416679144 -0.582669048855 -0.590012896042
2528+ -0.597449381028 -0.604979679101 -0.612604980713 -0.620326491686
2529+ -0.628145433422 -0.636063043114 -0.644080573960 -0.652199295382
2530+ -0.660420493246 -0.668745470088 -0.677175545343 -0.685712055576
2531+ -0.694356354720 -0.703109814309 -0.711973823731 -0.720949790466
2532+ -0.730039140342 -0.739243317789 -0.748563786097 -0.758002027682
2533+ -0.767559544350 -0.777237857572 -0.787038508760 -0.796963059547
2534+ -0.807013092074 -0.817190209278 -0.827496035191 -0.837932215238
2535+ -0.848500416544 -0.859202328242 -0.870039661792 -0.881014151299
2536+ -0.892127553843 -0.903381649810 -0.914778243232 -0.926319162128
2537+ -0.938006258858 -0.949841410476 -0.961826519097 -0.973963512262
2538+ -0.986254343317 -0.998700991797 -1.01130546381 -1.02406979244
2539+ -1.03699603815 -1.05008628918 -1.06334266201 -1.07676730172
2540+ -1.09036238248 -1.10413010797 -1.11807271183 -1.13219245815
2541+ -1.14649164188 -1.16097258937 -1.17563765882 -1.19048924079
2542+ -1.20552975870 -1.22076166936 -1.23618746347 -1.25180966620
2543+ -1.26763083770 -1.28365357365 -1.29988050589 -1.31631430294
2544+ -1.33295767061 -1.34981335263 -1.36688413124 -1.38417282784
2545+ -1.40168230361 -1.41941546018 -1.43737524033 -1.45556462861
2546+ -1.47398665211 -1.49264438111 -1.51154092987 -1.53067945733
2547+ -1.55006316788 -1.56969531216 -1.58957918782 -1.60971814036
2548+ -1.63011556394 -1.65077490224 -1.67169964932 -1.69289335048
2549+ -1.71435960322 -1.73610205810 -1.75812441974 -1.78043044773
2550+ -1.80302395767 -1.82590882212 -1.84908897170 -1.87256839606
2551+ -1.89635114505 -1.92044132971 -1.94484312351 -1.96956076342
2552+ -1.99459855110 -2.01996085413 -2.04565210721 -2.07167681344
2553+ -2.09803954555 -2.12474494729 -2.15179773470 -2.17920269753
2554+ -2.20696470062 -2.23508868531 -2.26357967093 -2.29244275629
2555+ -2.32168312121 -2.35130602804 -2.38131682331 -2.41172093930
2556+ -2.44252389574 -2.47373130148 -2.50534885624 -2.53738235233
2557+ -2.56983767651 -2.60272081176 -2.63603783923 -2.66979494005
2558+ -2.70399839735 -2.73865459822 -2.77377003571 -2.80935131090
2559+ -2.84540513495 -2.88193833129 -2.91895783772 -2.95647070865
2560+ -2.99448411726 -3.03300535784 -3.07204184804 -3.11160113119
2561+ -3.15169087868 -3.19231889232 -3.23349310675 -3.27522159191
2562+ -3.31751255544 -3.36037434521 -3.40381545179 -3.44784451097
2563+ -3.49247030628 -3.53770177150 -3.58354799326 -3.63001821347
2564+ -3.67712183197 -3.72486840895 -3.77326766751 -3.82232949613
2565+ -3.87206395109 -3.92248125895 -3.97359181887 -4.02540620495
2566+ -4.07793516848 -4.13118964014 -4.18518073209 -4.23991973998
2567+ -4.29541814487 -4.35168761496 -4.40874000730 -4.46658736924
2568+ -4.52524193977 -4.58471615069 -4.64502262748 -4.70617419008
2569+ -4.76818385331 -4.83106482712 -4.89483051643 -4.95949452074
2570+ -5.02507063336 -5.09157284027 -5.15901531855 -5.22741243438
2571+ -5.29677874055 -5.36712897347 -5.43847804961 -5.51084106131
2572+ -5.58423327202 -5.65867011078 -5.73416716597 -5.81074017827
2573+ -5.88840503279 -5.96717775028 -6.04707447730 -6.12811147550
2574+ -6.21030510965 -6.29367183458 -6.37822818085 -6.46399073910
2575+ -6.55097614295 -6.63920105049 -6.72868212411 -6.81943600870
2576+ -6.91147930804 -7.00482855941 -7.09950020610 -7.19551056795
2577+ -7.29287580964 -7.39161190669 -7.49173460907 -7.59325940222
2578+ -7.69620146543 -7.80057562742 -7.90639631901 -8.01367752275
2579+ -8.12243271931 -8.23267483065 -8.34441615960 -8.45766832601
2580+ -8.57244219906 -8.68874782577 -8.80659435555 -8.92598996058
2581+ -9.04694175207 -9.16945569209 -9.29353650104 -9.41918756057
2582+ -9.54641081190 -9.67520664950 -9.80557381009 -9.93750925686
2583+ -10.0710080591 -10.2060632670 -10.3426657822 -10.4808042232
2584+ -10.6204647875 -10.7616311084 -10.9042841091 -11.0484018527
2585+ -11.1939593889 -11.3409285989 -11.4892780376 -11.6389727745
2586+ -11.7899742343 -11.9422400377 -12.0957238430 -12.2503751910
2587+ -12.4061393529 -12.5629571835 -12.7207649812 -12.8794943563
2588+ -13.0390721098 -13.1994201243 -13.3604552701 -13.5220893281
2589+ -13.6842289332 -13.8467755397 -14.0096254135 -14.1726696535
2590+ -14.3357942460 -14.4988801559 -14.6618034591 -14.8244355200
2591+ -14.9866432189 -15.1482892329 -15.3092323756 -15.4693279995
2592+ -15.6284284640 -15.7863836724 -15.9430416970 -16.0982492953
2593+ -16.2518537434 -16.4036985526 -16.5536384383 -16.7015454972
2594+ -16.8470786609 -16.9907860453 -17.1304291968 -17.2630082265
2595+ -17.3916950955 -17.5186022815 -17.6429800079 -17.7650106218
2596+ -17.8846367581 -18.0018241640 -18.1165513928 -18.2287984911
2597+ -18.3385538778 -18.4458148854 -18.5505895102 -18.6528979269
2598+ -18.7527740015 -18.8502668082 -18.9454421711 -19.0383842437
2599+ -19.1291971409 -19.2180066292 -19.3049618876 -19.3902373357
2600+ -19.4740345486 -19.5565842523 -19.6381483910 -19.7190222998
2601+ -19.7995369524 -19.8800612771 -19.9610045438 -20.0428187832
2602+ -20.1260012146 -20.2110966222 -20.2986996275 -20.3894567566
2603+ -20.4840681812 -20.5832890169 -20.6879299683 -20.7988571108
2604+ -20.9169905638 -21.0433017254 -21.1788087493 -21.3245698477
2605+ -21.4816739744 -21.6512284780 -21.8343431398 -22.0321104415
2606+ -22.2455796747 -22.4757334352 -22.7234333871 -22.9894274945
2607+ -23.2742354596 -23.5781112300 -23.9010755557 -24.2426861525
2608+ -24.6020748277 -24.9779155742 -25.3682866811 -25.7706674995
2609+ -26.1818737878 -26.5980375239 -27.0146020196 -27.4263499290
2610+ -27.8274705686 -28.2116764077 -28.5723789514 -28.9029350281
2611+ -29.1969752129 -29.4488270662 -29.6540467726 -29.8100771572
2612+ -29.9170421718 -29.9787342448 -30.0037403026 -30.0069047125
2613+ -30.0060710840 -30.0053029068 -30.0046205298 -30.0040312326
2614+ -30.0035039851 -30.0030426788 -30.0026365663 -30.0022805302
2615+ -30.0019688109 -30.0016964272 -30.0014588623 -30.0012520615
2616+ -30.0010723889 -30.0007919083 -30.0005824716 -30.0004266961
2617+ -30.0003112940 -30.0002261473 -30.0001635825 -30.0001178034
2618+ -30.0000844500 -30.0000602557 -30.0000427842 -30.0000302250
2619+ -30.0000212399 -30.0000148431 -30.0000103117 -30.0000071190
2620+ -30.0000048815 -30.0000033227 -30.0000022433 -30.0000015006
2621+ -30.0000009936 -30.0000006497 -30.0000004188 -30.0000002651
2622+ -30.0000001639 -30.0000000983 -30.0000000563 -30.0000000300
2623+ -30.0000000140 -30.0000000045 -29.9999999993 -29.9999999966
2624+ -29.9999999955 -29.9999999953 -29.9999999956 -29.9999999961
2625+ -29.9999999966 -29.9999999972 -29.9999999977 -29.9999999982
2626+ -29.9999999985 -29.9999999989 -29.9999999991 -29.9999999993
2627+ -29.9999999995 -29.9999999996 -29.9999999997 -29.9999999998
2628+ -29.9999999998 -29.9999999999 -29.9999999999 -29.9999999999
2629+ -29.9999999999 -30.0000000000 -30.0000000000 -30.0000000000
2630+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
2631+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
2632+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
2633+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
2634+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
2635+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
2636+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
2637+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
2638+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
2639+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
2640+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
2641+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
2642+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
2643+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
2644+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
2645+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
2646+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
2647+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
2648+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
2649+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
2650+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
2651+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
2652+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
2653+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
2654+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
2655+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
2656+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
2657+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
2658+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
2659+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
2660+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
2661+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
2662+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
2663+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
2664+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
2665+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
2666+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
2667+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
2668+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
2669+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
2670+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
2671+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
2672+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
2673+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
2674+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
2675+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
2676+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
2677+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
2678+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
2679+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
2680+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
2681+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
2682+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
2683+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
2684+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
2685+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
2686+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
2687+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
2688+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
2689+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
2690+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
2691+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
2692+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
2693+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
2694+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
2695+ Down Pseudopotential follows (l on next line)
2696+ 2
2697+ -0.140097856392E-04 -0.281959262620E-04 -0.425602379214E-04 -0.571056340534E-04
2698+ -0.718335295773E-04 -0.867470623356E-04 -0.101847949390E-03 -0.117138886199E-03
2699+ -0.132622127695E-03 -0.148300130212E-03 -0.164175337344E-03 -0.180250229448E-03
2700+ -0.196527319830E-03 -0.213009150428E-03 -0.229698295930E-03 -0.246597366531E-03
2701+ -0.263709000627E-03 -0.281035871752E-03 -0.298580689931E-03 -0.316346193748E-03
2702+ -0.334335159278E-03 -0.352550398867E-03 -0.370994758950E-03 -0.389671119228E-03
2703+ -0.408582399102E-03 -0.427731554839E-03 -0.447121575220E-03 -0.466755494254E-03
2704+ -0.486636377319E-03 -0.506767330058E-03 -0.527151498565E-03 -0.547792069399E-03
2705+ -0.568692267504E-03 -0.589855355812E-03 -0.611284644090E-03 -0.632983479711E-03
2706+ -0.654955252370E-03 -0.677203395722E-03 -0.699731388200E-03 -0.722542746476E-03
2707+ -0.745641035992E-03 -0.769029866255E-03 -0.792712892292E-03 -0.816693815716E-03
2708+ -0.840976378419E-03 -0.865564379841E-03 -0.890461662517E-03 -0.915672111820E-03
2709+ -0.941199669082E-03 -0.967048324845E-03 -0.993222117891E-03 -0.101972513393E-02
2710+ -0.104656151795E-02 -0.107373546353E-02 -0.110125121249E-02 -0.112911306989E-02
2711+ -0.115732538467E-02 -0.118589256668E-02 -0.121481908089E-02 -0.124410944393E-02
2712+ -0.127376823529E-02 -0.130380008892E-02 -0.133420969624E-02 -0.136500180874E-02
2713+ -0.139618123998E-02 -0.142775285835E-02 -0.145972159869E-02 -0.149209245922E-02
2714+ -0.152487049264E-02 -0.155806082192E-02 -0.159166863586E-02 -0.162569918512E-02
2715+ -0.166015778429E-02 -0.169504981794E-02 -0.173038074248E-02 -0.176615607459E-02
2716+ -0.180238140248E-02 -0.183906239170E-02 -0.187620477091E-02 -0.191381434132E-02
2717+ -0.195189698351E-02 -0.199045864727E-02 -0.202950535567E-02 -0.206904321060E-02
2718+ -0.210907839295E-02 -0.214961715427E-02 -0.219066582972E-02 -0.223223083578E-02
2719+ -0.227431866371E-02 -0.231693589218E-02 -0.236008917901E-02 -0.240378526776E-02
2720+ -0.244803098613E-02 -0.249283324544E-02 -0.253819904934E-02 -0.258413548438E-02
2721+ -0.263064972822E-02 -0.267774905012E-02 -0.272544080730E-02 -0.277373245401E-02
2722+ -0.282263153552E-02 -0.287214568940E-02 -0.292228265597E-02 -0.297305026887E-02
2723+ -0.302445645887E-02 -0.307650925910E-02 -0.312921680267E-02 -0.318258732663E-02
2724+ -0.323662916769E-02 -0.329135077203E-02 -0.334676069071E-02 -0.340286757874E-02
2725+ -0.345968020452E-02 -0.351720744612E-02 -0.357545829164E-02 -0.363444184154E-02
2726+ -0.369416731323E-02 -0.375464403951E-02 -0.381588146931E-02 -0.387788917118E-02
2727+ -0.394067683322E-02 -0.400425426757E-02 -0.406863140774E-02 -0.413381831190E-02
2728+ -0.419982516719E-02 -0.426666228642E-02 -0.433434011288E-02 -0.440286922132E-02
2729+ -0.447226032072E-02 -0.454252425195E-02 -0.461367199482E-02 -0.468571466686E-02
2730+ -0.475866352296E-02 -0.483252996429E-02 -0.490732552972E-02 -0.498306190762E-02
2731+ -0.505975093368E-02 -0.513740458692E-02 -0.521603500361E-02 -0.529565446988E-02
2732+ -0.537627542513E-02 -0.545791046697E-02 -0.554057235143E-02 -0.562427399565E-02
2733+ -0.570902847577E-02 -0.579484903592E-02 -0.588174908680E-02 -0.596974220508E-02
2734+ -0.605884214054E-02 -0.614906281612E-02 -0.624041832726E-02 -0.633292294983E-02
2735+ -0.642659113792E-02 -0.652143752553E-02 -0.661747693476E-02 -0.671472437103E-02
2736+ -0.681319503003E-02 -0.691290429661E-02 -0.701386775159E-02 -0.711610117172E-02
2737+ -0.721962052859E-02 -0.732444199960E-02 -0.743058196276E-02 -0.753805700162E-02
2738+ -0.764688391095E-02 -0.775707969426E-02 -0.786866156908E-02 -0.798164697271E-02
2739+ -0.809605355718E-02 -0.821189919934E-02 -0.832920200113E-02 -0.844798028960E-02
2740+ -0.856825262596E-02 -0.869003780231E-02 -0.881335484739E-02 -0.893822303048E-02
2741+ -0.906466186229E-02 -0.919269109848E-02 -0.932233074477E-02 -0.945360105732E-02
2742+ -0.958652254740E-02 -0.972111598392E-02 -0.985740239814E-02 -0.999540308482E-02
2743+ -0.101351396057E-01 -0.102766337973E-01 -0.104199077662E-01 -0.105649839000E-01
2744+ -0.107118848682E-01 -0.108606336222E-01 -0.110112534062E-01 -0.111637677546E-01
2745+ -0.113182004968E-01 -0.114745757647E-01 -0.116329179918E-01 -0.117932519194E-01
2746+ -0.119556025997E-01 -0.121199954007E-01 -0.122864560095E-01 -0.124550104349E-01
2747+ -0.126256850144E-01 -0.127985064171E-01 -0.129735016456E-01 -0.131506980436E-01
2748+ -0.133301232988E-01 -0.135118054459E-01 -0.136957728744E-01 -0.138820543289E-01
2749+ -0.140706789159E-01 -0.142616761093E-01 -0.144550757524E-01 -0.146509080640E-01
2750+ -0.148492036440E-01 -0.150499934761E-01 -0.152533089339E-01 -0.154591817871E-01
2751+ -0.156676442026E-01 -0.158787287529E-01 -0.160924684218E-01 -0.163088966056E-01
2752+ -0.165280471217E-01 -0.167499542137E-01 -0.169746525541E-01 -0.172021772528E-01
2753+ -0.174325638617E-01 -0.176658483785E-01 -0.179020672545E-01 -0.181412573998E-01
2754+ -0.183834561887E-01 -0.186287014645E-01 -0.188770315476E-01 -0.191284852409E-01
2755+ -0.193831018338E-01 -0.196409211108E-01 -0.199019833572E-01 -0.201663293647E-01
2756+ -0.204340004373E-01 -0.207050383997E-01 -0.209794856026E-01 -0.212573849284E-01
2757+ -0.215387797999E-01 -0.218237141855E-01 -0.221122326073E-01 -0.224043801469E-01
2758+ -0.227002024526E-01 -0.229997457481E-01 -0.233030568375E-01 -0.236101831135E-01
2759+ -0.239211725663E-01 -0.242360737880E-01 -0.245549359829E-01 -0.248778089746E-01
2760+ -0.252047432118E-01 -0.255357897797E-01 -0.258710004054E-01 -0.262104274653E-01
2761+ -0.265541239969E-01 -0.269021437033E-01 -0.272545409631E-01 -0.276113708404E-01
2762+ -0.279726890898E-01 -0.283385521687E-01 -0.287090172444E-01 -0.290841422027E-01
2763+ -0.294639856584E-01 -0.298486069628E-01 -0.302380662140E-01 -0.306324242665E-01
2764+ -0.310317427396E-01 -0.314360840280E-01 -0.318455113115E-01 -0.322600885640E-01
2765+ -0.326798805645E-01 -0.331049529070E-01 -0.335353720102E-01 -0.339712051283E-01
2766+ -0.344125203616E-01 -0.348593866674E-01 -0.353118738694E-01 -0.357700526705E-01
2767+ -0.362339946627E-01 -0.367037723380E-01 -0.371794591011E-01 -0.376611292796E-01
2768+ -0.381488581360E-01 -0.386427218796E-01 -0.391427976782E-01 -0.396491636705E-01
2769+ -0.401618989779E-01 -0.406810837173E-01 -0.412067990128E-01 -0.417391270095E-01
2770+ -0.422781508857E-01 -0.428239548655E-01 -0.433766242333E-01 -0.439362453457E-01
2771+ -0.445029056450E-01 -0.450766936750E-01 -0.456576990917E-01 -0.462460126794E-01
2772+ -0.468417263650E-01 -0.474449332309E-01 -0.480557275304E-01 -0.486742047030E-01
2773+ -0.493004613884E-01 -0.499345954416E-01 -0.505767059489E-01 -0.512268932430E-01
2774+ -0.518852589185E-01 -0.525519058478E-01 -0.532269381979E-01 -0.539104614455E-01
2775+ -0.546025823942E-01 -0.553034091916E-01 -0.560130513448E-01 -0.567316197393E-01
2776+ -0.574592266549E-01 -0.581959857835E-01 -0.589420122479E-01 -0.596974226186E-01
2777+ -0.604623349323E-01 -0.612368687107E-01 -0.620211449790E-01 -0.628152862848E-01
2778+ -0.636194167169E-01 -0.644336619256E-01 -0.652581491413E-01 -0.660930071950E-01
2779+ -0.669383665383E-01 -0.677943592639E-01 -0.686611191259E-01 -0.695387815611E-01
2780+ -0.704274837097E-01 -0.713273644375E-01 -0.722385643568E-01 -0.731612258487E-01
2781+ -0.740954930856E-01 -0.750415120530E-01 -0.759994305735E-01 -0.769693983288E-01
2782+ -0.779515668834E-01 -0.789460897088E-01 -0.799531222067E-01 -0.809728217337E-01
2783+ -0.820053476265E-01 -0.830508612252E-01 -0.841095259001E-01 -0.851815070768E-01
2784+ -0.862669722613E-01 -0.873660910672E-01 -0.884790352418E-01 -0.896059786926E-01
2785+ -0.907470975151E-01 -0.919025700201E-01 -0.930725767613E-01 -0.942573005638E-01
2786+ -0.954569265528E-01 -0.966716421821E-01 -0.979016372638E-01 -0.991471039979E-01
2787+ -0.100408237002 -0.101685233343 -0.102978292565 -0.104287616725
2788+ -0.105613410419 -0.106955880819 -0.108315237703 -0.109691693487
2789+ -0.111085463260 -0.112496764818 -0.113925818696 -0.115372848202
2790+ -0.116838079455 -0.118321741420 -0.119824065939 -0.121345287775
2791+ -0.122885644640 -0.124445377240 -0.126024729308 -0.127623947645
2792+ -0.129243282154 -0.130882985884 -0.132543315068 -0.134224529162
2793+ -0.135926890887 -0.137650666269 -0.139396124679 -0.141163538881
2794+ -0.142953185069 -0.144765342910 -0.146600295594 -0.148458329871
2795+ -0.150339736099 -0.152244808290 -0.154173844155 -0.156127145153
2796+ -0.158105016532 -0.160107767385 -0.162135710691 -0.164189163368
2797+ -0.166268446324 -0.168373884501 -0.170505806933 -0.172664546793
2798+ -0.174850441447 -0.177063832504 -0.179305065876 -0.181574491823
2799+ -0.183872465016 -0.186199344588 -0.188555494192 -0.190941282055
2800+ -0.193357081041 -0.195803268705 -0.198280227352 -0.200788344101
2801+ -0.203328010940 -0.205899624794 -0.208503587579 -0.211140306272
2802+ -0.213810192972 -0.216513664963 -0.219251144784 -0.222023060289
2803+ -0.224829844719 -0.227671936767 -0.230549780649 -0.233463826171
2804+ -0.236414528802 -0.239402349743 -0.242427756002 -0.245491220464
2805+ -0.248593221969 -0.251734245383 -0.254914781675 -0.258135327998
2806+ -0.261396387762 -0.264698470713 -0.268042093018 -0.271427777339
2807+ -0.274856052922 -0.278327455674 -0.281842528251 -0.285401820141
2808+ -0.289005887751 -0.292655294495 -0.296350610881 -0.300092414601
2809+ -0.303881290623 -0.307717831280 -0.311602636367 -0.315536313230
2810+ -0.319519476867 -0.323552750020 -0.327636763277 -0.331772155165
2811+ -0.335959572257 -0.340199669270 -0.344493109169 -0.348840563269
2812+ -0.353242711344 -0.357700241733 -0.362213851445 -0.366784246271
2813+ -0.371412140899 -0.376098259018 -0.380843333439 -0.385648106208
2814+ -0.390513328720 -0.395439761842 -0.400428176031 -0.405479351454
2815+ -0.410594078113 -0.415773155967 -0.421017395060 -0.426327615650
2816+ -0.431704648334 -0.437149334183 -0.442662524874 -0.448245082823
2817+ -0.453897881319 -0.459621804670 -0.465417748333 -0.471286619061
2818+ -0.477229335046 -0.483246826061 -0.489340033611 -0.495509911080
2819+ -0.501757423879 -0.508083549605 -0.514489278189 -0.520975612060
2820+ -0.527543566296 -0.534194168789 -0.540928460410 -0.547747495168
2821+ -0.554652340384 -0.561644076854 -0.568723799026 -0.575892615170
2822+ -0.583151647555 -0.590502032628 -0.597944921194 -0.605481478601
2823+ -0.613112884922 -0.620840335145 -0.628665039364 -0.636588222969
2824+ -0.644611126843 -0.652735007563 -0.660961137595 -0.669290805499
2825+ -0.677725316138 -0.686265990881 -0.694914167820 -0.703671201981
2826+ -0.712538465541 -0.721517348046 -0.730609256640 -0.739815616284
2827+ -0.749137869988 -0.758577479043 -0.768135923253 -0.777814701177
2828+ -0.787615330366 -0.797539347612 -0.807588309192 -0.817763791119
2829+ -0.828067389400 -0.838500720290 -0.849065420556 -0.859763147739
2830+ -0.870595580426 -0.881564418518 -0.892671383510 -0.903918218768
2831+ -0.915306689813 -0.926838584608 -0.938515713849 -0.950339911262
2832+ -0.962313033899 -0.974436962444 -0.986713601519 -0.999144879999
2833+ -1.01173275132 -1.02447919382 -1.03738621102 -1.05045583202
2834+ -1.06369011177 -1.07709113143 -1.09066099875 -1.10440184836
2835+ -1.11831584215 -1.13240516963 -1.14667204832 -1.16111872405
2836+ -1.17574747140 -1.19056059404 -1.20556042514 -1.22074932774
2837+ -1.23612969515 -1.25170395138 -1.26747455149 -1.28344398205
2838+ -1.29961476157 -1.31598944086 -1.33257060353 -1.34936086640
2839+ -1.36636287992 -1.38357932869 -1.40101293183 -1.41866644353
2840+ -1.43654265344 -1.45464438722 -1.47297450699 -1.49153591181
2841+ -1.51033153822 -1.52936436073 -1.54863739230 -1.56815368494
2842+ -1.58791633018 -1.60792845961 -1.62819324549 -1.64871390123
2843+ -1.66949368200 -1.69053588532 -1.71184385157 -1.73342096469
2844+ -1.75527065267 -1.77739638825 -1.79980168949 -1.82249012045
2845+ -1.84546529176 -1.86873086133 -1.89229053500 -1.91614806721
2846+ -1.94030726167 -1.96477197208 -1.98954610282 -2.01463360968
2847+ -2.04003850057 -2.06576483630 -2.09181673130 -2.11819835439
2848+ -2.14491392959 -2.17196773688 -2.19936411304 -2.22710745243
2849+ -2.25520220787 -2.28365289145 -2.31246407544 -2.34164039311
2850+ -2.37118653967 -2.40110727316 -2.43140741540 -2.46209185289
2851+ -2.49316553782 -2.52463348898 -2.55650079282 -2.58877260443
2852+ -2.62145414856 -2.65455072067 -2.68806768803 -2.72201049075
2853+ -2.75638464292 -2.79119573374 -2.82644942863 -2.86215147043
2854+ -2.89830768056 -2.93492396027 -2.97200629181 -3.00956073973
2855+ -3.04759345215 -3.08611066202 -3.12511868851 -3.16462393830
2856+ -3.20463290697 -3.24515218042 -3.28618843625 -3.32774844527
2857+ -3.36983907289 -3.41246728070 -3.45564012799 -3.49936477325
2858+ -3.54364847583 -3.58849859752 -3.63392260419 -3.67992806748
2859+ -3.72652266650 -3.77371418957 -3.82151053597 -3.86991971777
2860+ -3.91894986162 -3.96860921064 -4.01890612632 -4.06984909042
2861+ -4.12144670695 -4.17370770414 -4.22664093650 -4.28025538686
2862+ -4.33456016846 -4.38956452707 -4.44527784318 -4.50170963416
2863+ -4.55886955649 -4.61676740805 -4.67541313036 -4.73481681096
2864+ -4.79498868571 -4.85593914122 -4.91767871723 -4.98021810908
2865+ -5.04356817017 -5.10773991447 -5.17274451901 -5.23859332648
2866+ -5.30529784778 -5.37286976458 -5.44132093197 -5.51066338106
2867+ -5.58090932163 -5.65207114476 -5.72416142551 -5.79719292554
2868+ -5.87117859577 -5.94613157906 -6.02206521282 -6.09899303162
2869+ -6.17692876983 -6.25588636415 -6.33587995617 -6.41692389487
2870+ -6.49903273905 -6.58222125974 -6.66650444248 -6.75189748964
2871+ -6.83841582248 -6.92607508328 -7.01489113724 -7.10488007434
2872+ -7.19605821096 -7.28844209145 -7.38204848945 -7.47689440906
2873+ -7.57299708580 -7.67037398730 -7.76904281379 -7.86902149827
2874+ -7.97032820643 -8.07298133619 -8.17699951691 -8.28240160820
2875+ -8.38920669835 -8.49743410226 -8.60710335889 -8.71823422818
2876+ -8.83084668746 -8.94496092711 -9.06059734569 -9.17777654431
2877+ -9.29651932020 -9.41684665950 -9.53877972918 -9.66233986795
2878+ -9.78754857627 -9.91442750515 -10.0429984439 -10.1732833067
2879+ -10.3053041175 -10.4390829942 -10.5746421304 -10.7120037766
2880+ -10.8511902190 -10.9922237566 -11.1351266764 -11.2799212272
2881+ -11.4266295902 -11.5752738480 -11.7258759511 -11.8784576819
2882+ -12.0330406154 -12.1896460784 -12.3482951041 -12.5090083844
2883+ -12.6718062191 -12.8367084608 -13.0037344570 -13.1729029870
2884+ -13.3442321965 -13.5177395259 -13.6934416362 -13.8713543283
2885+ -14.0514924583 -14.2338698480 -14.4184991889 -14.6053919419
2886+ -14.7945582299 -14.9860067254 -15.1797445311 -15.3757770542
2887+ -15.5741078742 -15.7747386035 -15.9776687403 -16.1828955157
2888+ -16.3904137312 -16.6002155899 -16.8122905198 -17.0266249881
2889+ -17.2432023084 -17.4620024391 -17.6830017746 -17.9061729270
2890+ -18.1314845009 -18.3589008597 -18.5883818846 -18.8198827259
2891+ -19.0533535476 -19.2887392652 -19.5259792779 -19.7650071954
2892+ -20.0057505605 -20.2481305680 -20.4920617822 -20.7374518527
2893+ -20.9842012313 -21.2322028915 -21.4813420515 -21.7314959047
2894+ -21.9825333587 -22.2343147854 -22.4866917863 -22.7395069756
2895+ -22.9925937839 -23.2457762882 -23.4988690703 -23.7516771105
2896+ -24.0039957191 -24.2556105132 -24.5062974431 -24.7558228753
2897+ -25.0039437369 -25.2504077302 -25.4949536218 -25.7373116138
2898+ -25.9772038034 -26.2143447360 -26.4484420730 -26.6791971819
2899+ -26.9063070769 -27.1294602789 -27.3483519672 -27.5626903829
2900+ -27.7719665532 -27.9765569609 -28.1740481625 -28.3612623456
2901+ -28.5411910965 -28.7157646026 -28.8840494793 -29.0460438002
2902+ -29.2015059739 -29.3502183357 -29.4919776604 -29.6265847183
2903+ -29.7538520630 -29.8736055161 -29.9856868833 -30.0899564464
2904+ -30.1862954484 -30.2746085609 -30.3548263321 -30.4269076066
2905+ -30.4908419022 -30.5466517209 -30.5943947724 -30.6341660697
2906+ -30.6660998777 -30.6903714661 -30.7071986147 -30.7168428591
2907+ -30.7196104031 -30.7158526445 -30.7059662756 -30.6903928831
2908+ -30.6696179872 -30.6441694381 -30.6146150967 -30.5815596972
2909+ -30.5456407748 -30.5075235671 -30.4678947167 -30.4274546204
2910+ -30.3869082529 -30.3469542200 -30.3082718212 -30.2715058102
2911+ -30.2372485058 -30.2060189331 -30.1782384624 -30.1542028008
2912+ -30.1340478716 -30.1177179503 -30.1049026076 -30.0950341320
2913+ -30.0871613879 -30.0801780141 -30.0738500694 -30.0680896888
2914+ -30.0628188469 -30.0580018355 -30.0535686536 -30.0494667609
2915+ -30.0456405375 -30.0420387803 -30.0386144876 -30.0353269058
2916+ -30.0321436171 -30.0290429129 -30.0260161581 -30.0230697709
2917+ -30.0202262970 -30.0175239775 -30.0150137190 -30.0127546360
2918+ -30.0107981094 -30.0091915038 -30.0079147003 -30.0069051317
2919+ -30.0060710840 -30.0053029068 -30.0046205298 -30.0040312326
2920+ -30.0035039851 -30.0030426788 -30.0026365663 -30.0022805302
2921+ -30.0019688109 -30.0016964272 -30.0014588623 -30.0012520615
2922+ -30.0010723889 -30.0007919083 -30.0005824716 -30.0004266961
2923+ -30.0003112940 -30.0002261473 -30.0001635825 -30.0001178034
2924+ -30.0000844500 -30.0000602557 -30.0000427842 -30.0000302250
2925+ -30.0000212399 -30.0000148431 -30.0000103117 -30.0000071190
2926+ -30.0000048815 -30.0000033227 -30.0000022433 -30.0000015006
2927+ -30.0000009936 -30.0000006497 -30.0000004188 -30.0000002651
2928+ -30.0000001639 -30.0000000983 -30.0000000563 -30.0000000300
2929+ -30.0000000140 -30.0000000045 -29.9999999993 -29.9999999966
2930+ -29.9999999955 -29.9999999953 -29.9999999956 -29.9999999961
2931+ -29.9999999966 -29.9999999972 -29.9999999977 -29.9999999982
2932+ -29.9999999985 -29.9999999989 -29.9999999991 -29.9999999993
2933+ -29.9999999995 -29.9999999996 -29.9999999997 -29.9999999998
2934+ -29.9999999998 -29.9999999999 -29.9999999999 -29.9999999999
2935+ -29.9999999999 -30.0000000000 -30.0000000000 -30.0000000000
2936+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
2937+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
2938+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
2939+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
2940+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
2941+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
2942+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
2943+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
2944+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
2945+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
2946+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
2947+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
2948+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
2949+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
2950+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
2951+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
2952+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
2953+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
2954+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
2955+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
2956+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
2957+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
2958+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
2959+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
2960+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
2961+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
2962+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
2963+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
2964+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
2965+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
2966+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
2967+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
2968+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
2969+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
2970+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
2971+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
2972+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
2973+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
2974+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
2975+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
2976+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
2977+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
2978+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
2979+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
2980+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
2981+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
2982+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
2983+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
2984+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
2985+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
2986+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
2987+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
2988+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
2989+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
2990+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
2991+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
2992+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
2993+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
2994+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
2995+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
2996+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
2997+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
2998+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
2999+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
3000+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
3001+ Down Pseudopotential follows (l on next line)
3002+ 3
3003+ -0.107149210866E-04 -0.215647528627E-04 -0.325507900762E-04 -0.436754183009E-04
3004+ -0.549395179543E-04 -0.663456856534E-04 -0.778950904275E-04 -0.895898728082E-04
3005+ -0.101431725821E-03 -0.113422536828E-03 -0.125564173289E-03 -0.137858532184E-03
3006+ -0.150307536104E-03 -0.162913128839E-03 -0.175677279408E-03 -0.188601984719E-03
3007+ -0.201689262162E-03 -0.214941156460E-03 -0.228359740913E-03 -0.241947109373E-03
3008+ -0.255705385072E-03 -0.269636719304E-03 -0.283743289134E-03 -0.298027296475E-03
3009+ -0.312490974413E-03 -0.327136584268E-03 -0.341966411135E-03 -0.356982776480E-03
3010+ -0.372188024182E-03 -0.387584529304E-03 -0.403174698174E-03 -0.418960968280E-03
3011+ -0.434945806071E-03 -0.451131706442E-03 -0.467521201466E-03 -0.484116851038E-03
3012+ -0.500921247470E-03 -0.517937017003E-03 -0.535166820502E-03 -0.552613346785E-03
3013+ -0.570279323029E-03 -0.588167509931E-03 -0.606280703030E-03 -0.624621733644E-03
3014+ -0.643193462417E-03 -0.661998796463E-03 -0.681040674760E-03 -0.700322067764E-03
3015+ -0.719845990381E-03 -0.739615495070E-03 -0.759633670736E-03 -0.779903641263E-03
3016+ -0.800428577704E-03 -0.821211687472E-03 -0.842256213797E-03 -0.863565450605E-03
3017+ -0.885142722970E-03 -0.906991404004E-03 -0.929114908900E-03 -0.951516691304E-03
3018+ -0.974200254355E-03 -0.997169142100E-03 -0.102042694236E-02 -0.104397728915E-02
3019+ -0.106782386447E-02 -0.109197039095E-02 -0.111642064325E-02 -0.114117844479E-02
3020+ -0.116624765874E-02 -0.119163220352E-02 -0.121733604829E-02 -0.124336320869E-02
3021+ -0.126971774876E-02 -0.129640378678E-02 -0.132342549699E-02 -0.135078709771E-02
3022+ -0.137849286250E-02 -0.140654712570E-02 -0.143495426805E-02 -0.146371872584E-02
3023+ -0.149284499760E-02 -0.152233763364E-02 -0.155220124000E-02 -0.158244048368E-02
3024+ -0.161306009267E-02 -0.164406484728E-02 -0.167545959298E-02 -0.170724923781E-02
3025+ -0.173943874559E-02 -0.177203314838E-02 -0.180503753791E-02 -0.183845707193E-02
3026+ -0.187229697243E-02 -0.190656252480E-02 -0.194125908630E-02 -0.197639207639E-02
3027+ -0.201196698467E-02 -0.204798937111E-02 -0.208446486213E-02 -0.212139915942E-02
3028+ -0.215879803364E-02 -0.219666732544E-02 -0.223501295559E-02 -0.227384091531E-02
3029+ -0.231315726979E-02 -0.235296816308E-02 -0.239327981549E-02 -0.243409852716E-02
3030+ -0.247543067358E-02 -0.251728271499E-02 -0.255966119158E-02 -0.260257272215E-02
3031+ -0.264602401331E-02 -0.269002185538E-02 -0.273457312248E-02 -0.277968477448E-02
3032+ -0.282536386127E-02 -0.287161752087E-02 -0.291845297985E-02 -0.296587755640E-02
3033+ -0.301389865999E-02 -0.306252379544E-02 -0.311176055996E-02 -0.316161664597E-02
3034+ -0.321209984516E-02 -0.326321804474E-02 -0.331497923188E-02 -0.336739149433E-02
3035+ -0.342046302276E-02 -0.347420210810E-02 -0.352861714809E-02 -0.358371664578E-02
3036+ -0.363950920862E-02 -0.369600355709E-02 -0.375320851562E-02 -0.381113302404E-02
3037+ -0.386978613488E-02 -0.392917700901E-02 -0.398931492910E-02 -0.405020929181E-02
3038+ -0.411186961069E-02 -0.417430552071E-02 -0.423752677801E-02 -0.430154326207E-02
3039+ -0.436636497321E-02 -0.443200204100E-02 -0.449846472245E-02 -0.456576340083E-02
3040+ -0.463390859238E-02 -0.470291094583E-02 -0.477278124120E-02 -0.484353039724E-02
3041+ -0.491516946873E-02 -0.498770964757E-02 -0.506116227046E-02 -0.513553881359E-02
3042+ -0.521085089902E-02 -0.528711029305E-02 -0.536432891239E-02 -0.544251882361E-02
3043+ -0.552169224146E-02 -0.560186153925E-02 -0.568303924301E-02 -0.576523803590E-02
3044+ -0.584847076323E-02 -0.593275042936E-02 -0.601809020237E-02 -0.610450341919E-02
3045+ -0.619200357988E-02 -0.628060435712E-02 -0.637031959577E-02 -0.646116331228E-02
3046+ -0.655314970302E-02 -0.664629314035E-02 -0.674060817769E-02 -0.683610955269E-02
3047+ -0.693281218743E-02 -0.703073119123E-02 -0.712988186505E-02 -0.723027970106E-02
3048+ -0.733194038664E-02 -0.743487980616E-02 -0.753911404486E-02 -0.764465938928E-02
3049+ -0.775153232993E-02 -0.785974956837E-02 -0.796932801160E-02 -0.808028478209E-02
3050+ -0.819263721838E-02 -0.830640287333E-02 -0.842159952506E-02 -0.853824517309E-02
3051+ -0.865635804216E-02 -0.877595658914E-02 -0.889705950116E-02 -0.901968570078E-02
3052+ -0.914385434827E-02 -0.926958484556E-02 -0.939689683873E-02 -0.952581021961E-02
3053+ -0.965634513158E-02 -0.978852197191E-02 -0.992236139241E-02 -0.100578843060E-01
3054+ -0.101951118890E-01 -0.103340655824E-01 -0.104747670995E-01 -0.106172384244E-01
3055+ -0.107615018182E-01 -0.109075798233E-01 -0.110554952642E-01 -0.112052712528E-01
3056+ -0.113569311926E-01 -0.115104987804E-01 -0.116659980111E-01 -0.118234531832E-01
3057+ -0.119828888980E-01 -0.121443300677E-01 -0.123078019192E-01 -0.124733299942E-01
3058+ -0.126409401571E-01 -0.128106585979E-01 -0.129825118347E-01 -0.131565267203E-01
3059+ -0.133327304455E-01 -0.135111505418E-01 -0.136918148878E-01 -0.138747517132E-01
3060+ -0.140599896025E-01 -0.142475574989E-01 -0.144374847103E-01 -0.146298009143E-01
3061+ -0.148245361598E-01 -0.150217208748E-01 -0.152213858704E-01 -0.154235623447E-01
3062+ -0.156282818876E-01 -0.158355764875E-01 -0.160454785352E-01 -0.162580208276E-01
3063+ -0.164732365755E-01 -0.166911594066E-01 -0.169118233722E-01 -0.171352629517E-01
3064+ -0.173615130576E-01 -0.175906090427E-01 -0.178225867036E-01 -0.180574822871E-01
3065+ -0.182953324970E-01 -0.185361744975E-01 -0.187800459209E-01 -0.190269848732E-01
3066+ -0.192770299384E-01 -0.195302201876E-01 -0.197865951827E-01 -0.200461949818E-01
3067+ -0.203090601492E-01 -0.205752317581E-01 -0.208447513981E-01 -0.211176611833E-01
3068+ -0.213940037560E-01 -0.216738222957E-01 -0.219571605251E-01 -0.222440627163E-01
3069+ -0.225345736990E-01 -0.228287388663E-01 -0.231266041823E-01 -0.234282161898E-01
3070+ -0.237336220161E-01 -0.240428693821E-01 -0.243560066089E-01 -0.246730826249E-01
3071+ -0.249941469743E-01 -0.253192498247E-01 -0.256484419745E-01 -0.259817748607E-01
3072+ -0.263193005680E-01 -0.266610718362E-01 -0.270071420679E-01 -0.273575653379E-01
3073+ -0.277123964013E-01 -0.280716907013E-01 -0.284355043793E-01 -0.288038942824E-01
3074+ -0.291769179731E-01 -0.295546337376E-01 -0.299371005954E-01 -0.303243783085E-01
3075+ -0.307165273905E-01 -0.311136091165E-01 -0.315156855319E-01 -0.319228194627E-01
3076+ -0.323350745256E-01 -0.327525151367E-01 -0.331752065234E-01 -0.336032147329E-01
3077+ -0.340366066429E-01 -0.344754499734E-01 -0.349198132954E-01 -0.353697660424E-01
3078+ -0.358253785222E-01 -0.362867219261E-01 -0.367538683409E-01 -0.372268907607E-01
3079+ -0.377058630979E-01 -0.381908601939E-01 -0.386819578319E-01 -0.391792327486E-01
3080+ -0.396827626459E-01 -0.401926262026E-01 -0.407089030880E-01 -0.412316739731E-01
3081+ -0.417610205435E-01 -0.422970255129E-01 -0.428397726347E-01 -0.433893467167E-01
3082+ -0.439458336331E-01 -0.445093203379E-01 -0.450798948798E-01 -0.456576464143E-01
3083+ -0.462426652188E-01 -0.468350427063E-01 -0.474348714396E-01 -0.480422451459E-01
3084+ -0.486572587314E-01 -0.492800082964E-01 -0.499105911497E-01 -0.505491058244E-01
3085+ -0.511956520931E-01 -0.518503309834E-01 -0.525132447937E-01 -0.531844971096E-01
3086+ -0.538641928192E-01 -0.545524381306E-01 -0.552493405877E-01 -0.559550090872E-01
3087+ -0.566695538958E-01 -0.573930866672E-01 -0.581257204596E-01 -0.588675697539E-01
3088+ -0.596187504704E-01 -0.603793799884E-01 -0.611495771633E-01 -0.619294623457E-01
3089+ -0.627191574007E-01 -0.635187857257E-01 -0.643284722710E-01 -0.651483435587E-01
3090+ -0.659785277021E-01 -0.668191544269E-01 -0.676703550901E-01 -0.685322627015E-01
3091+ -0.694050119442E-01 -0.702887391955E-01 -0.711835825486E-01 -0.720896818337E-01
3092+ -0.730071786402E-01 -0.739362163388E-01 -0.748769401038E-01 -0.758294969360E-01
3093+ -0.767940356855E-01 -0.777707070747E-01 -0.787596637228E-01 -0.797610601685E-01
3094+ -0.807750528950E-01 -0.818018003543E-01 -0.828414629915E-01 -0.838942032706E-01
3095+ -0.849601856992E-01 -0.860395768552E-01 -0.871325454115E-01 -0.882392621636E-01
3096+ -0.893599000557E-01 -0.904946342079E-01 -0.916436419435E-01 -0.928071028167E-01
3097+ -0.939851986412E-01 -0.951781135176E-01 -0.963860338634E-01 -0.976091484411E-01
3098+ -0.988476483886E-01 -0.100101727248 -0.101371580998 -0.102657408082
3099+ -0.103959409440 -0.105277788541 -0.106612751414 -0.107964506680
3100+ -0.109333265586 -0.110719242036 -0.112122652626 -0.113543716677
3101+ -0.114982656271 -0.116439696283 -0.117915064419 -0.119408991249
3102+ -0.120921710245 -0.122453457818 -0.124004473352 -0.125574999245
3103+ -0.127165280945 -0.128775566989 -0.130406109040 -0.132057161930
3104+ -0.133728983698 -0.135421835629 -0.137135982298 -0.138871691609
3105+ -0.140629234837 -0.142408886671 -0.144210925260 -0.146035632250
3106+ -0.147883292834 -0.149754195795 -0.151648633548 -0.153566902193
3107+ -0.155509301553 -0.157476135227 -0.159467710634 -0.161484339065
3108+ -0.163526335728 -0.165594019799 -0.167687714471 -0.169807747007
3109+ -0.171954448791 -0.174128155375 -0.176329206540 -0.178557946340
3110+ -0.180814723165 -0.183099889789 -0.185413803428 -0.187756825796
3111+ -0.190129323160 -0.192531666402 -0.194964231070 -0.197427397445
3112+ -0.199921550594 -0.202447080433 -0.205004381792 -0.207593854468
3113+ -0.210215903297 -0.212870938212 -0.215559374310 -0.218281631915
3114+ -0.221038136647 -0.223829319485 -0.226655616838 -0.229517470614
3115+ -0.232415328285 -0.235349642962 -0.238320873464 -0.241329484392
3116+ -0.244375946198 -0.247460735264 -0.250584333974 -0.253747230791
3117+ -0.256949920333 -0.260192903451 -0.263476687308 -0.266801785461
3118+ -0.270168717937 -0.273578011321 -0.277030198834 -0.280525820418
3119+ -0.284065422825 -0.287649559697 -0.291278791658 -0.294953686401
3120+ -0.298674818778 -0.302442770888 -0.306258132175 -0.310121499513
3121+ -0.314033477308 -0.317994677587 -0.322005720101 -0.326067232416
3122+ -0.330179850018 -0.334344216412 -0.338560983222 -0.342830810295
3123+ -0.347154365808 -0.351532326368 -0.355965377127 -0.360454211883
3124+ -0.364999533196 -0.369602052495 -0.374262490193 -0.378981575801
3125+ -0.383760048046 -0.388598654982 -0.393498154117 -0.398459312528
3126+ -0.403482906984 -0.408569724070 -0.413720560314 -0.418936222310
3127+ -0.424217526849 -0.429565301050 -0.434980382490 -0.440463619338
3128+ -0.446015870493 -0.451638005715 -0.457330905772 -0.463095462575
3129+ -0.468932579322 -0.474843170645 -0.480828162752 -0.486888493582
3130+ -0.493025112948 -0.499238982695 -0.505531076852 -0.511902381789
3131+ -0.518353896377 -0.524886632144 -0.531501613446 -0.538199877625
3132+ -0.544982475178 -0.551850469929 -0.558804939200 -0.565846973982
3133+ -0.572977679117 -0.580198173471 -0.587509590121 -0.594913076536
3134+ -0.602409794762 -0.610000921613 -0.617687648864 -0.625471183442
3135+ -0.633352747622 -0.641333579232 -0.649414931850 -0.657598075010
3136+ -0.665884294414 -0.674274892134 -0.682771186838 -0.691374513995
3137+ -0.700086226101 -0.708907692901 -0.717840301615 -0.726885457166
3138+ -0.736044582413 -0.745319118387 -0.754710524529 -0.764220278933
3139+ -0.773849878595 -0.783600839655 -0.793474697657 -0.803473007803
3140+ -0.813597345213 -0.823849305188 -0.834230503482 -0.844742576570
3141+ -0.855387181923 -0.866165998294 -0.877080725994 -0.888133087186
3142+ -0.899324826174 -0.910657709704 -0.922133527259 -0.933754091370
3143+ -0.945521237924 -0.957436826478 -0.969502740582 -0.981720888100
3144+ -0.994093201542 -1.00662163840 -1.01930818148 -1.03215483925
3145+ -1.04516364620 -1.05833666320 -1.07167597782 -1.08518370475
3146+ -1.09886198617 -1.11271299206 -1.12673892067 -1.14094199888
3147+ -1.15532448256 -1.16988865703 -1.18463683744 -1.19957136919
3148+ -1.21469462835 -1.23000902210 -1.24551698915 -1.26122100023
3149+ -1.27712355846 -1.29322719990 -1.30953449395 -1.32604804386
3150+ -1.34277048719 -1.35970449634 -1.37685277899 -1.39421807866
3151+ -1.41180317522 -1.42961088538 -1.44764406326 -1.46590560092
3152+ -1.48439842894 -1.50312551692 -1.52208987414 -1.54129455008
3153+ -1.56074263502 -1.58043726069 -1.60038160084 -1.62057887187
3154+ -1.64103233352 -1.66174528946 -1.68272108798 -1.70396312266
3155+ -1.72547483309 -1.74725970551 -1.76932127357 -1.79166311905
3156+ -1.81428887259 -1.83720221447 -1.86040687535 -1.88390663709
3157+ -1.90770533351 -1.93180685126 -1.95621513059 -1.98093416628
3158+ -2.00596800842 -2.03132076337 -2.05699659461 -2.08299972369
3159+ -2.10933443116 -2.13600505751 -2.16301600421 -2.19037173462
3160+ -2.21807677509 -2.24613571595 -2.27455321260 -2.30333398659
3161+ -2.33248282669 -2.36200459011 -2.39190420355 -2.42218666446
3162+ -2.45285704221 -2.48392047934 -2.51538219278 -2.54724747519
3163+ -2.57952169625 -2.61221030398 -2.64531882615 -2.67885287166
3164+ -2.71281813197 -2.74722038258 -2.78206548454 -2.81735938592
3165+ -2.85310812345 -2.88931782407 -2.92599470658 -2.96314508332
3166+ -3.00077536185 -3.03889204675 -3.07750174133 -3.11661114953
3167+ -3.15622707775 -3.19635643675 -3.23700624364 -3.27818362381
3168+ -3.31989581304 -3.36215015954 -3.40495412608 -3.44831529219
3169+ -3.49224135637 -3.53674013835 -3.58181958144 -3.62748775489
3170+ -3.67375285630 -3.72062321413 -3.76810729019 -3.81621368224
3171+ -3.86495112663 -3.91432850098 -3.96435482693 -4.01503927294
3172+ -4.06639115714 -4.11841995025 -4.17113527854 -4.22454692687
3173+ -4.27866484175 -4.33349913451 -4.38906008445 -4.44535814214
3174+ -4.50240393268 -4.56020825910 -4.61878210575 -4.67813664176
3175+ -4.73828322459 -4.79923340358 -4.86099892355 -4.92359172850
3176+ -4.98702396527 -5.05130798733 -5.11645635856 -5.18248185702
3177+ -5.24939747886 -5.31721644217 -5.38595219088 -5.45561839867
3178+ -5.52622897289 -5.59779805851 -5.67034004203 -5.74386955538
3179+ -5.81840147985 -5.89395094991 -5.97053335710 -6.04816435373
3180+ -6.12685985669 -6.20663605101 -6.28750939347 -6.36949661604
3181+ -6.45261472919 -6.53688102514 -6.62231308086 -6.70892876095
3182+ -6.79674622033 -6.88578390668 -6.97606056264 -7.06759522777
3183+ -7.16040724015 -7.25451623772 -7.34994215921 -7.44670524469
3184+ -7.54482603566 -7.64432537470 -7.74522440459 -7.84754456685
3185+ -7.95130759968 -8.05653553528 -8.16325069636 -8.27147569197
3186+ -8.38123341249 -8.49254702363 -8.60543995956 -8.71993591499
3187+ -8.83605883610 -8.95383291028 -9.07328255464 -9.19443240308
3188+ -9.31730729196 -9.44193224413 -9.56833245142 -9.69653325521
3189+ -9.82656012520 -9.95843863611 -10.0921944423 -10.2278532501
3190+ -10.3654407877 -10.5049827723 -10.6465048751 -10.7900326829
3191+ -10.9355916568 -11.0832070878 -11.2329040487 -11.3847073435
3192+ -11.5386414512 -11.6947304676 -11.8529980418 -12.0134673086
3193+ -12.1761608166 -12.3411004512 -12.5083073533 -12.6778018320
3194+ -12.8496032725 -13.0237300383 -13.2001993676 -13.3790272639
3195+ -13.5602283803 -13.7438158973 -13.9298013948 -14.1181947172
3196+ -14.3090038312 -14.5022346780 -14.6978910180 -14.8959742686
3197+ -15.0964833358 -15.2994144387 -15.5047609279 -15.7125130974
3198+ -15.9226579904 -16.1351792003 -16.3500566656 -16.5672664614
3199+ -16.7867805862 -17.0085667462 -17.2325881378 -17.4588032285
3200+ -17.6871655387 -17.9176234247 -18.1501198656 -18.3845922542
3201+ -18.6209721960 -18.8591853164 -19.0991510795 -19.3407826216
3202+ -19.5839866011 -19.8286630681 -20.0747053582 -20.3220000130
3203+ -20.5704267300 -20.8198583487 -21.0701608732 -21.3211935374
3204+ -21.5728089145 -21.8248530737 -22.0771658028 -22.3295806998
3205+ -22.5819265595 -22.8340226204 -23.0856930423 -23.3367725698
3206+ -23.5868754506 -23.8364972282 -24.0833384119 -24.3243290123
3207+ -24.5625612120 -24.8000573956 -25.0359667277 -25.2703588603
3208+ -25.5030514115 -25.7338720884 -25.9626476645 -26.1891919341
3209+ -26.4133118455 -26.6348072779 -26.8534720124 -27.0690944481
3210+ -27.2814582962 -27.4903432547 -27.6955256804 -27.8967792697
3211+ -28.0938757536 -28.2865856130 -28.4746788164 -28.6579255751
3212+ -28.8360971279 -29.0089665475 -29.1763095565 -29.3379053880
3213+ -29.4935376667 -29.6429953128 -29.7860734901 -29.9225745876
3214+ -30.0523092503 -30.1750974533 -30.2907696399 -30.3991679158
3215+ -30.5001472998 -30.5935770587 -30.6793421040 -30.7573444519
3216+ -30.8275047662 -30.8897639496 -30.9440848122 -30.9904537866
3217+ -31.0288826690 -31.0594104383 -31.0821050455 -31.0970655082
3218+ -31.1044223915 -31.1043456444 -31.0970270170 -31.0827294650
3219+ -31.0617203020 -31.0342867227 -31.0008261023 -30.9616776296
3220+ -30.9172231042 -30.8679187566 -30.8142182622 -30.7566238819
3221+ -30.6956650345 -30.6319045751 -30.5659369712 -30.4983882712
3222+ -30.4299155517 -30.3612059818 -30.2929750834 -30.2259636744
3223+ -30.1609328189 -30.0986560210 -30.0399074042 -29.9854468823
3224+ -29.9359921199 -29.8922083134 -29.8546288851 -29.8236628038
3225+ -29.7995884273 -29.7825438004 -29.7726523101 -29.7698583899
3226+ -29.7738807082 -29.7842666532 -29.8003284272 -29.8211560373
3227+ -29.8456141096 -29.8723609652 -29.8998857610 -29.9265721152
3228+ -29.9507956806 -29.9710651869 -29.9862184312 -29.9956871355
3229+ -29.9998690308 -30.0003517263 -30.0002550615 -30.0001836818
3230+ -30.0001316764 -30.0000939521 -30.0000667101 -30.0000471275
3231+ -30.0000331178 -30.0000231437 -30.0000160783 -30.0000111001
3232+ -30.0000076113 -30.0000051808 -30.0000034978 -30.0000023398
3233+ -30.0000015492 -30.0000010130 -30.0000006530 -30.0000004133
3234+ -30.0000002556 -30.0000001533 -30.0000000877 -30.0000000468
3235+ -30.0000000218 -30.0000000071 -29.9999999989 -29.9999999947
3236+ -29.9999999930 -29.9999999927 -29.9999999931 -29.9999999939
3237+ -29.9999999948 -29.9999999956 -29.9999999964 -29.9999999971
3238+ -29.9999999977 -29.9999999982 -29.9999999986 -29.9999999989
3239+ -29.9999999992 -29.9999999994 -29.9999999995 -29.9999999996
3240+ -29.9999999997 -29.9999999998 -29.9999999999 -29.9999999999
3241+ -29.9999999999 -29.9999999999 -30.0000000000 -30.0000000000
3242+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
3243+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
3244+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
3245+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
3246+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
3247+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
3248+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
3249+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
3250+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
3251+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
3252+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
3253+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
3254+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
3255+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
3256+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
3257+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
3258+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
3259+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
3260+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
3261+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
3262+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
3263+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
3264+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
3265+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
3266+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
3267+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
3268+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
3269+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
3270+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
3271+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
3272+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
3273+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
3274+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
3275+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
3276+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
3277+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
3278+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
3279+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
3280+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
3281+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
3282+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
3283+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
3284+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
3285+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
3286+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
3287+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
3288+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
3289+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
3290+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
3291+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
3292+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
3293+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
3294+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
3295+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
3296+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
3297+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
3298+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
3299+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
3300+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
3301+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
3302+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
3303+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
3304+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
3305+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
3306+ -30.0000000000 -30.0000000000 -30.0000000000 -30.0000000000
3307+ Up Pseudopotential follows (l on next line)
3308+ 1
3309+ -0.194261042817E-05 -0.390965588748E-05 -0.590144373278E-05 -0.791828518497E-05
3310+ -0.996049537962E-05 -0.120283934163E-04 -0.141223024081E-04 -0.162425495328E-04
3311+ -0.183894660832E-04 -0.205633875193E-04 -0.227646535209E-04 -0.249936080402E-04
3312+ -0.272505993560E-04 -0.295359801276E-04 -0.318501074505E-04 -0.341933429118E-04
3313+ -0.365660526468E-04 -0.389686073962E-04 -0.414013825642E-04 -0.438647582766E-04
3314+ -0.463591194411E-04 -0.488848558067E-04 -0.514423620247E-04 -0.540320377107E-04
3315+ -0.566542875069E-04 -0.593095211450E-04 -0.619981535108E-04 -0.647206047085E-04
3316+ -0.674773001267E-04 -0.702686705046E-04 -0.730951519996E-04 -0.759571862550E-04
3317+ -0.788552204697E-04 -0.817897074673E-04 -0.847611057673E-04 -0.877698796569E-04
3318+ -0.908164992631E-04 -0.939014406263E-04 -0.970251857750E-04 -0.100188222801E-03
3319+ -0.103391045934E-03 -0.106634155624E-03 -0.109918058611E-03 -0.113243268013E-03
3320+ -0.116610303400E-03 -0.120019690878E-03 -0.123471963172E-03 -0.126967659706E-03
3321+ -0.130507326689E-03 -0.134091517201E-03 -0.137720791281E-03 -0.141395716008E-03
3322+ -0.145116865598E-03 -0.148884821488E-03 -0.152700172428E-03 -0.156563514576E-03
3323+ -0.160475451585E-03 -0.164436594704E-03 -0.168447562871E-03 -0.172508982806E-03
3324+ -0.176621489114E-03 -0.180785724384E-03 -0.185002339286E-03 -0.189271992674E-03
3325+ -0.193595351690E-03 -0.197973091868E-03 -0.202405897238E-03 -0.206894460436E-03
3326+ -0.211439482809E-03 -0.216041674526E-03 -0.220701754687E-03 -0.225420451442E-03
3327+ -0.230198502095E-03 -0.235036653226E-03 -0.239935660807E-03 -0.244896290318E-03
3328+ -0.249919316866E-03 -0.255005525311E-03 -0.260155710382E-03 -0.265370676806E-03
3329+ -0.270651239433E-03 -0.275998223360E-03 -0.281412464066E-03 -0.286894807537E-03
3330+ -0.292446110399E-03 -0.298067240055E-03 -0.303759074818E-03 -0.309522504049E-03
3331+ -0.315358428295E-03 -0.321267759431E-03 -0.327251420803E-03 -0.333310347369E-03
3332+ -0.339445485850E-03 -0.345657794872E-03 -0.351948245123E-03 -0.358317819497E-03
3333+ -0.364767513254E-03 -0.371298334171E-03 -0.377911302703E-03 -0.384607452139E-03
3334+ -0.391387828766E-03 -0.398253492032E-03 -0.405205514711E-03 -0.412244983069E-03
3335+ -0.419372997040E-03 -0.426590670389E-03 -0.433899130892E-03 -0.441299520512E-03
3336+ -0.448792995574E-03 -0.456380726949E-03 -0.464063900235E-03 -0.471843715944E-03
3337+ -0.479721389688E-03 -0.487698152369E-03 -0.495775250373E-03 -0.503953945763E-03
3338+ -0.512235516477E-03 -0.520621256527E-03 -0.529112476201E-03 -0.537710502271E-03
3339+ -0.546416678194E-03 -0.555232364330E-03 -0.564158938147E-03 -0.573197794440E-03
3340+ -0.582350345549E-03 -0.591618021578E-03 -0.601002270621E-03 -0.610504558986E-03
3341+ -0.620126371425E-03 -0.629869211365E-03 -0.639734601145E-03 -0.649724082253E-03
3342+ -0.659839215564E-03 -0.670081581590E-03 -0.680452780721E-03 -0.690954433477E-03
3343+ -0.701588180763E-03 -0.712355684125E-03 -0.723258626005E-03 -0.734298710012E-03
3344+ -0.745477661180E-03 -0.756797226244E-03 -0.768259173909E-03 -0.779865295127E-03
3345+ -0.791617403378E-03 -0.803517334953E-03 -0.815566949241E-03 -0.827768129019E-03
3346+ -0.840122780744E-03 -0.852632834858E-03 -0.865300246082E-03 -0.878126993723E-03
3347+ -0.891115081989E-03 -0.904266540293E-03 -0.917583423578E-03 -0.931067812634E-03
3348+ -0.944721814424E-03 -0.958547562415E-03 -0.972547216906E-03 -0.986722965373E-03
3349+ -0.100107702281E-02 -0.101561163205E-02 -0.103032906418E-02 -0.104523161881E-02
3350+ -0.106032162451E-02 -0.107560143911E-02 -0.109107345011E-02 -0.110674007506E-02
3351+ -0.112260376189E-02 -0.113866698934E-02 -0.115493226731E-02 -0.117140213730E-02
3352+ -0.118807917274E-02 -0.120496597947E-02 -0.122206519608E-02 -0.123937949436E-02
3353+ -0.125691157970E-02 -0.127466419152E-02 -0.129264010371E-02 -0.131084212505E-02
3354+ -0.132927309962E-02 -0.134793590732E-02 -0.136683346423E-02 -0.138596872316E-02
3355+ -0.140534467401E-02 -0.142496434431E-02 -0.144483079969E-02 -0.146494714432E-02
3356+ -0.148531652141E-02 -0.150594211373E-02 -0.152682714406E-02 -0.154797487573E-02
3357+ -0.156938861312E-02 -0.159107170216E-02 -0.161302753090E-02 -0.163525952995E-02
3358+ -0.165777117314E-02 -0.168056597793E-02 -0.170364750607E-02 -0.172701936410E-02
3359+ -0.175068520391E-02 -0.177464872334E-02 -0.179891366673E-02 -0.182348382554E-02
3360+ -0.184836303891E-02 -0.187355519425E-02 -0.189906422790E-02 -0.192489412569E-02
3361+ -0.195104892360E-02 -0.197753270837E-02 -0.200434961814E-02 -0.203150384311E-02
3362+ -0.205899962618E-02 -0.208684126363E-02 -0.211503310576E-02 -0.214357955762E-02
3363+ -0.217248507964E-02 -0.220175418836E-02 -0.223139145715E-02 -0.226140151689E-02
3364+ -0.229178905671E-02 -0.232255882473E-02 -0.235371562879E-02 -0.238526433719E-02
3365+ -0.241720987950E-02 -0.244955724726E-02 -0.248231149482E-02 -0.251547774009E-02
3366+ -0.254906116538E-02 -0.258306701815E-02 -0.261750061189E-02 -0.265236732692E-02
3367+ -0.268767261124E-02 -0.272342198137E-02 -0.275962102321E-02 -0.279627539295E-02
3368+ -0.283339081790E-02 -0.287097309743E-02 -0.290902810384E-02 -0.294756178330E-02
3369+ -0.298658015678E-02 -0.302608932099E-02 -0.306609544930E-02 -0.310660479275E-02
3370+ -0.314762368102E-02 -0.318915852339E-02 -0.323121580976E-02 -0.327380211167E-02
3371+ -0.331692408331E-02 -0.336058846259E-02 -0.340480207214E-02 -0.344957182044E-02
3372+ -0.349490470284E-02 -0.354080780272E-02 -0.358728829251E-02 -0.363435343488E-02
3373+ -0.368201058387E-02 -0.373026718600E-02 -0.377913078146E-02 -0.382860900529E-02
3374+ -0.387870958856E-02 -0.392944035959E-02 -0.398080924516E-02 -0.403282427177E-02
3375+ -0.408549356687E-02 -0.413882536015E-02 -0.419282798481E-02 -0.424750987886E-02
3376+ -0.430287958647E-02 -0.435894575926E-02 -0.441571715769E-02 -0.447320265240E-02
3377+ -0.453141122563E-02 -0.459035197257E-02 -0.465003410284E-02 -0.471046694189E-02
3378+ -0.477165993248E-02 -0.483362263613E-02 -0.489636473466E-02 -0.495989603162E-02
3379+ -0.502422645393E-02 -0.508936605334E-02 -0.515532500804E-02 -0.522211362426E-02
3380+ -0.528974233785E-02 -0.535822171594E-02 -0.542756245856E-02 -0.549777540036E-02
3381+ -0.556887151224E-02 -0.564086190312E-02 -0.571375782164E-02 -0.578757065794E-02
3382+ -0.586231194543E-02 -0.593799336258E-02 -0.601462673477E-02 -0.609222403611E-02
3383+ -0.617079739135E-02 -0.625035907773E-02 -0.633092152693E-02 -0.641249732699E-02
3384+ -0.649509922430E-02 -0.657874012557E-02 -0.666343309986E-02 -0.674919138063E-02
3385+ -0.683602836777E-02 -0.692395762975E-02 -0.701299290570E-02 -0.710314810754E-02
3386+ -0.719443732222E-02 -0.728687481387E-02 -0.738047502602E-02 -0.747525258391E-02
3387+ -0.757122229671E-02 -0.766839915990E-02 -0.776679835755E-02 -0.786643526474E-02
3388+ -0.796732544994E-02 -0.806948467744E-02 -0.817292890983E-02 -0.827767431049E-02
3389+ -0.838373724610E-02 -0.849113428920E-02 -0.859988222080E-02 -0.870999803299E-02
3390+ -0.882149893159E-02 -0.893440233883E-02 -0.904872589612E-02 -0.916448746672E-02
3391+ -0.928170513864E-02 -0.940039722735E-02 -0.952058227876E-02 -0.964227907200E-02
3392+ -0.976550662247E-02 -0.989028418470E-02 -0.100166312555E-01 -0.101445675767E-01
3393+ -0.102741131388E-01 -0.104052881834E-01 -0.105381132070E-01 -0.106726089637E-01
3394+ -0.108087964688E-01 -0.109466970018E-01 -0.110863321100E-01 -0.112277236116E-01
3395+ -0.113708935993E-01 -0.115158644438E-01 -0.116626587971E-01 -0.118112995960E-01
3396+ -0.119618100660E-01 -0.121142137246E-01 -0.122685343853E-01 -0.124247961609E-01
3397+ -0.125830234677E-01 -0.127432410290E-01 -0.129054738791E-01 -0.130697473673E-01
3398+ -0.132360871616E-01 -0.134045192529E-01 -0.135750699591E-01 -0.137477659291E-01
3399+ -0.139226341470E-01 -0.140997019363E-01 -0.142789969641E-01 -0.144605472458E-01
3400+ -0.146443811489E-01 -0.148305273979E-01 -0.150190150784E-01 -0.152098736420E-01
3401+ -0.154031329109E-01 -0.155988230821E-01 -0.157969747326E-01 -0.159976188240E-01
3402+ -0.162007867074E-01 -0.164065101281E-01 -0.166148212310E-01 -0.168257525649E-01
3403+ -0.170393370884E-01 -0.172556081744E-01 -0.174745996158E-01 -0.176963456305E-01
3404+ -0.179208808666E-01 -0.181482404082E-01 -0.183784597809E-01 -0.186115749567E-01
3405+ -0.188476223604E-01 -0.190866388750E-01 -0.193286618472E-01 -0.195737290935E-01
3406+ -0.198218789064E-01 -0.200731500596E-01 -0.203275818147E-01 -0.205852139274E-01
3407+ -0.208460866531E-01 -0.211102407536E-01 -0.213777175037E-01 -0.216485586971E-01
3408+ -0.219228066532E-01 -0.222005042239E-01 -0.224816948000E-01 -0.227664223181E-01
3409+ -0.230547312674E-01 -0.233466666968E-01 -0.236422742218E-01 -0.239416000316E-01
3410+ -0.242446908966E-01 -0.245515941752E-01 -0.248623578217E-01 -0.251770303937E-01
3411+ -0.254956610592E-01 -0.258182996050E-01 -0.261449964440E-01 -0.264758026232E-01
3412+ -0.268107698318E-01 -0.271499504091E-01 -0.274933973526E-01 -0.278411643268E-01
3413+ -0.281933056708E-01 -0.285498764075E-01 -0.289109322517E-01 -0.292765296191E-01
3414+ -0.296467256351E-01 -0.300215781436E-01 -0.304011457159E-01 -0.307854876602E-01
3415+ -0.311746640308E-01 -0.315687356373E-01 -0.319677640540E-01 -0.323718116300E-01
3416+ -0.327809414985E-01 -0.331952175868E-01 -0.336147046265E-01 -0.340394681631E-01
3417+ -0.344695745668E-01 -0.349050910426E-01 -0.353460856408E-01 -0.357926272676E-01
3418+ -0.362447856961E-01 -0.367026315768E-01 -0.371662364491E-01 -0.376356727521E-01
3419+ -0.381110138361E-01 -0.385923339741E-01 -0.390797083734E-01 -0.395732131869E-01
3420+ -0.400729255259E-01 -0.405789234713E-01 -0.410912860863E-01 -0.416100934284E-01
3421+ -0.421354265623E-01 -0.426673675723E-01 -0.432059995751E-01 -0.437514067329E-01
3422+ -0.443036742667E-01 -0.448628884692E-01 -0.454291367186E-01 -0.460025074923E-01
3423+ -0.465830903804E-01 -0.471709761001E-01 -0.477662565095E-01 -0.483690246223E-01
3424+ -0.489793746219E-01 -0.495974018766E-01 -0.502232029543E-01 -0.508568756373E-01
3425+ -0.514985189381E-01 -0.521482331145E-01 -0.528061196853E-01 -0.534722814465E-01
3426+ -0.541468224867E-01 -0.548298482042E-01 -0.555214653227E-01 -0.562217819083E-01
3427+ -0.569309073867E-01 -0.576489525596E-01 -0.583760296226E-01 -0.591122521826E-01
3428+ -0.598577352752E-01 -0.606125953832E-01 -0.613769504545E-01 -0.621509199203E-01
3429+ -0.629346247144E-01 -0.637281872916E-01 -0.645317316468E-01 -0.653453833347E-01
3430+ -0.661692694892E-01 -0.670035188433E-01 -0.678482617491E-01 -0.687036301984E-01
3431+ -0.695697578433E-01 -0.704467800166E-01 -0.713348337538E-01 -0.722340578137E-01
3432+ -0.731445927005E-01 -0.740665806856E-01 -0.750001658299E-01 -0.759454940063E-01
3433+ -0.769027129225E-01 -0.778719721439E-01 -0.788534231173E-01 -0.798472191941E-01
3434+ -0.808535156548E-01 -0.818724697327E-01 -0.829042406388E-01 -0.839489895867E-01
3435+ -0.850068798176E-01 -0.860780766258E-01 -0.871627473845E-01 -0.882610615724E-01
3436+ -0.893731907992E-01 -0.904993088335E-01 -0.916395916292E-01 -0.927942173531E-01
3437+ -0.939633664131E-01 -0.951472214857E-01 -0.963459675452E-01 -0.975597918923E-01
3438+ -0.987888841831E-01 -0.100033436459 -0.101293643177 -0.102569701239
3439+ -0.103861810024 -0.105170171418 -0.106494989846 -0.107836472303
3440+ -0.109194828389 -0.110570270338 -0.111963013055 -0.113373274145
3441+ -0.114801273952 -0.116247235590 -0.117711384977 -0.119193950874
3442+ -0.120695164917 -0.122215261657 -0.123754478592 -0.125313056207
3443+ -0.126891238012 -0.128489270576 -0.130107403572 -0.131745889809
3444+ -0.133404985275 -0.135084949178 -0.136786043983 -0.138508535457
3445+ -0.140252692705 -0.142018788217 -0.143807097909 -0.145617901164
3446+ -0.147451480876 -0.149308123497 -0.151188119079 -0.153091761318
3447+ -0.155019347603 -0.156971179060 -0.158947560598 -0.160948800960
3448+ -0.162975212766 -0.165027112567 -0.167104820888 -0.169208662284
3449+ -0.171338965385 -0.173496062952 -0.175680291923 -0.177891993471
3450+ -0.180131513051 -0.182399200460 -0.184695409884 -0.187020499959
3451+ -0.189374833823 -0.191758779172 -0.194172708320 -0.196616998253
3452+ -0.199092030686 -0.201598192129 -0.204135873937 -0.206705472379
3453+ -0.209307388692 -0.211942029145 -0.214609805106 -0.217311133097
3454+ -0.220046434862 -0.222816137435 -0.225620673198 -0.228460479952
3455+ -0.231336000982 -0.234247685127 -0.237195986844 -0.240181366281
3456+ -0.243204289345 -0.246265227773 -0.249364659202 -0.252503067245
3457+ -0.255680941559 -0.258898777922 -0.262157078306 -0.265456350954
3458+ -0.268797110454 -0.272179877815 -0.275605180550 -0.279073552747
3459+ -0.282585535152 -0.286141675251 -0.289742527344 -0.293388652635
3460+ -0.297080619305 -0.300819002602 -0.304604384922 -0.308437355893
3461+ -0.312318512458 -0.316248458967 -0.320227807255 -0.324257176735
3462+ -0.328337194485 -0.332468495332 -0.336651721947 -0.340887524929
3463+ -0.345176562898 -0.349519502584 -0.353917018918 -0.358369795125
3464+ -0.362878522814 -0.367443902069 -0.372066641545 -0.376747458556
3465+ -0.381487079172 -0.386286238309 -0.391145679825 -0.396066156608
3466+ -0.401048430675 -0.406093273260 -0.411201464909 -0.416373795573
3467+ -0.421611064696 -0.426914081311 -0.432283664127 -0.437720641622
3468+ -0.443225852128 -0.448800143924 -0.454444375318 -0.460159414736
3469+ -0.465946140803 -0.471805442429 -0.477738218884 -0.483745379884
3470+ -0.489827845658 -0.495986547028 -0.502222425477 -0.508536433218
3471+ -0.514929533257 -0.521402699452 -0.527956916574 -0.534593180355
3472+ -0.541312497539 -0.548115885921 -0.555004374387 -0.561979002942
3473+ -0.569040822738 -0.576190896089 -0.583430296483 -0.590760108583
3474+ -0.598181428219 -0.605695362377 -0.613303029167 -0.621005557793
3475+ -0.628804088498 -0.636699772512 -0.644693771970 -0.652787259832
3476+ -0.660981419773 -0.669277446072 -0.677676543470 -0.686179927019
3477+ -0.694788821906 -0.703504463259 -0.712328095930 -0.721260974252
3478+ -0.730304361772 -0.739459530960 -0.748727762884 -0.758110346854
3479+ -0.767608580042 -0.777223767053 -0.786957219472 -0.796810255363
3480+ -0.806784198730 -0.816880378933 -0.827100130054 -0.837444790216
3481+ -0.847915700845 -0.858514205879 -0.869241650912 -0.880099382281
3482+ -0.891088746074 -0.902211087076 -0.913467747636 -0.924860066446
3483+ -0.936389377247 -0.948057007430 -0.959864276552 -0.971812494738
3484+ -0.983902960990 -0.996136961367 -1.00851576705 -1.02104063227
3485+ -1.03371279214 -1.04653346028 -1.05950382631 -1.07262505324
3486+ -1.08589827462 -1.09932459155 -1.11290506945 -1.12664073471
3487+ -1.14053257109 -1.15458151587 -1.16878845581 -1.18315422283
3488+ -1.19767958949 -1.21236526411 -1.22721188566 -1.24222001834
3489+ -1.25739014584 -1.27272266526 -1.28821788066 -1.30387599629
3490+ -1.31969710938 -1.33568120255 -1.35182813582 -1.36813763807
3491+ -1.38460929820 -1.40124255561 -1.41803669032 -1.43499081249
3492+ -1.45210385133 -1.46937454356 -1.48680142110 -1.50438279824
3493+ -1.52211675811 -1.54000113844 -1.55803351662 -1.57621119404
3494+ -1.59453117958 -1.61299017242 -1.63158454388 -1.65031031851
3495+ -1.66916315423 -1.68813832160 -1.70723068213 -1.72643466557
3496+ -1.74574424632 -1.76515291870 -1.78465367127 -1.80423896002
3497+ -1.82390068051 -1.84363013892 -1.86341802195 -1.88325436559
3498+ -1.90312852284 -1.92302913017 -1.94294407291 -1.96286044952
3499+ -1.98276453471 -2.00264174147 -2.02247658201 -2.04225262769
3500+ -2.06195246789 -2.08155766801 -2.10104872652 -2.12040503118
3501+ -2.13960481460 -2.15862510907 -2.17744170096 -2.19602908462
3502+ -2.21436041613 -2.23240746685 -2.25014057713 -2.26752861027
3503+ -2.28453890691 -2.30113724032 -2.31728777247 -2.33295301155
3504+ -2.34809377101 -2.36266913050 -2.37663639915 -2.38995108146
3505+ -2.40256684631 -2.41443549945 -2.42550696006 -2.43572924166
3506+ -2.44504843812 -2.45340871516 -2.46075230803 -2.46701952575
3507+ -2.47214876284 -2.47607651884 -2.47873742655 -2.48006428937
3508+ -2.47998812874 -2.47843824196 -2.47534227150 -2.47062628603
3509+ -2.46421487419 -2.45603125156 -2.44599738151 -2.43403411047
3510+ -2.42006131841 -2.40399808474 -2.38576287046 -2.36527371686
3511+ -2.34244846125 -2.31720497008 -2.28946138994 -2.25913641663
3512+ -2.22614958276 -2.19042156412 -2.15187450531 -2.11043236490
3513+ -2.06602128074 -2.01856995605 -1.96801006698 -1.91427669297
3514+ -1.85730877096 -1.79704957552 -1.73344722698 -1.66645523046
3515+ -1.59603304937 -1.52214671769 -1.44476949639 -1.36388258025
3516+ -1.27947586278 -1.19154876787 -1.10011115858 -1.00518433459
3517+ -0.906802131585 -0.805012137044 -0.699877038453 -0.591476120977
3518+ -0.479906932489 -0.365287134221 -0.247756554988 -0.127479465837
3519+ -0.464708969260E-02 0.120519642990 0.247767086939 0.376805624821
3520+ 0.507306171571 0.638896464422 0.771157178646 0.903617928520
3521+ 1.03575323651 1.16697858143 1.29664666852 1.42404410100
3522+ 1.54838867364 1.66882755324 1.78443665842 1.89422159960
3523+ 1.99712058843 2.09200977015 2.17771147055 2.25300587567
3524+ 2.31664667197 2.36738116160 2.40397532331 2.42524420634
3525+ 2.43008791359 2.41753324114 2.38678078515 2.33725699450
3526+ 2.26867023255 2.18106940753 2.07490314005 1.95107676011
3527+ 1.81100367765 1.65664686656 1.49054536911 1.31581989683
3528+ 1.13615081212 0.955721055995 0.779115966110 0.611171406297
3529+ 0.456761163819 0.320514059200 0.206450463486 0.117526627198
3530+ 0.550729766924E-01 0.181088247083E-01 0.251029086208E-02 0.418293836901E-06
3531+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
3532+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
3533+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
3534+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
3535+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
3536+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
3537+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
3538+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
3539+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
3540+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
3541+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
3542+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
3543+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
3544+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
3545+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
3546+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
3547+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
3548+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
3549+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
3550+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
3551+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
3552+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
3553+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
3554+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
3555+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
3556+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
3557+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
3558+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
3559+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
3560+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
3561+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
3562+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
3563+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
3564+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
3565+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
3566+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
3567+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
3568+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
3569+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
3570+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
3571+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
3572+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
3573+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
3574+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
3575+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
3576+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
3577+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
3578+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
3579+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
3580+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
3581+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
3582+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
3583+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
3584+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
3585+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
3586+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
3587+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
3588+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
3589+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
3590+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
3591+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
3592+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
3593+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
3594+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
3595+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
3596+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
3597+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
3598+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
3599+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
3600+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
3601+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
3602+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
3603+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
3604+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
3605+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
3606+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
3607+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
3608+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
3609+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
3610+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
3611+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
3612+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
3613+ Up Pseudopotential follows (l on next line)
3614+ 2
3615+ 0.228378855447E-06 0.459630363260E-06 0.693790656957E-06 0.930896324562E-06
3616+ 0.117098441432E-05 0.141409244047E-05 0.166025838916E-05 0.190952072430E-05
3617+ 0.216191839364E-05 0.241749083484E-05 0.267627798160E-05 0.293832026995E-05
3618+ 0.320365864452E-05 0.347233456498E-05 0.374439001248E-05 0.401986749625E-05
3619+ 0.429881006020E-05 0.458126128967E-05 0.486726531824E-05 0.515686683463E-05
3620+ 0.545011108966E-05 0.574704390334E-05 0.604771167203E-05 0.635216137567E-05
3621+ 0.666044058516E-05 0.697259746975E-05 0.728868080458E-05 0.760873997832E-05
3622+ 0.793282500087E-05 0.826098651117E-05 0.859327578513E-05 0.892974474361E-05
3623+ 0.927044596059E-05 0.961543267131E-05 0.996475878065E-05 0.103184788715E-04
3624+ 0.106766482134E-04 0.110393227711E-04 0.114065592130E-04 0.117784149208E-04
3625+ 0.121549479975E-04 0.125362172773E-04 0.129222823343E-04 0.133132034919E-04
3626+ 0.137090418323E-04 0.141098592061E-04 0.145157182418E-04 0.149266823558E-04
3627+ 0.153428157619E-04 0.157641834819E-04 0.161908513553E-04 0.166228860500E-04
3628+ 0.170603550721E-04 0.175033267770E-04 0.179518703802E-04 0.184060559672E-04
3629+ 0.188659545057E-04 0.193316378557E-04 0.198031787811E-04 0.202806509612E-04
3630+ 0.207641290020E-04 0.212536884479E-04 0.217494057935E-04 0.222513584958E-04
3631+ 0.227596249858E-04 0.232742846812E-04 0.237954179986E-04 0.243231063663E-04
3632+ 0.248574322365E-04 0.253984790987E-04 0.259463314927E-04 0.265010750215E-04
3633+ 0.270627963649E-04 0.276315832929E-04 0.282075246798E-04 0.287907105175E-04
3634+ 0.293812319301E-04 0.299791811875E-04 0.305846517208E-04 0.311977381358E-04
3635+ 0.318185362286E-04 0.324471430000E-04 0.330836566714E-04 0.337281766990E-04
3636+ 0.343808037906E-04 0.350416399205E-04 0.357107883456E-04 0.363883536217E-04
3637+ 0.370744416198E-04 0.377691595426E-04 0.384726159411E-04 0.391849207318E-04
3638+ 0.399061852138E-04 0.406365220861E-04 0.413760454654E-04 0.421248709037E-04
3639+ 0.428831154064E-04 0.436508974509E-04 0.444283370047E-04 0.452155555441E-04
3640+ 0.460126760739E-04 0.468198231456E-04 0.476371228776E-04 0.484647029747E-04
3641+ 0.493026927480E-04 0.501512231350E-04 0.510104267203E-04 0.518804377563E-04
3642+ 0.527613921840E-04 0.536534276543E-04 0.545566835494E-04 0.554713010051E-04
3643+ 0.563974229322E-04 0.573351940390E-04 0.582847608542E-04 0.592462717496E-04
3644+ 0.602198769632E-04 0.612057286228E-04 0.622039807698E-04 0.632147893830E-04
3645+ 0.642383124033E-04 0.652747097584E-04 0.663241433874E-04 0.673867772664E-04
3646+ 0.684627774341E-04 0.695523120179E-04 0.706555512596E-04 0.717726675426E-04
3647+ 0.729038354187E-04 0.740492316351E-04 0.752090351623E-04 0.763834272219E-04
3648+ 0.775725913152E-04 0.787767132514E-04 0.799959811770E-04 0.812305856051E-04
3649+ 0.824807194452E-04 0.837465780333E-04 0.850283591622E-04 0.863262631129E-04
3650+ 0.876404926856E-04 0.889712532313E-04 0.903187526840E-04 0.916832015933E-04
3651+ 0.930648131571E-04 0.944638032550E-04 0.958803904820E-04 0.973147961828E-04
3652+ 0.987672444863E-04 0.100237962340E-03 0.101727179548E-03 0.103235128801E-03
3653+ 0.104762045722E-03 0.106308168893E-03 0.107873739899E-03 0.109459003364E-03
3654+ 0.111064206989E-03 0.112689601590E-03 0.114335441138E-03 0.116001982799E-03
3655+ 0.117689486974E-03 0.119398217338E-03 0.121128440884E-03 0.122880427964E-03
3656+ 0.124654452328E-03 0.126450791171E-03 0.128269725176E-03 0.130111538553E-03
3657+ 0.131976519091E-03 0.133864958197E-03 0.135777150942E-03 0.137713396111E-03
3658+ 0.139673996246E-03 0.141659257694E-03 0.143669490658E-03 0.145705009239E-03
3659+ 0.147766131493E-03 0.149853179473E-03 0.151966479284E-03 0.154106361135E-03
3660+ 0.156273159386E-03 0.158467212604E-03 0.160688863614E-03 0.162938459554E-03
3661+ 0.165216351927E-03 0.167522896659E-03 0.169858454152E-03 0.172223389341E-03
3662+ 0.174618071754E-03 0.177042875563E-03 0.179498179649E-03 0.181984367659E-03
3663+ 0.184501828064E-03 0.187050954223E-03 0.189632144442E-03 0.192245802037E-03
3664+ 0.194892335397E-03 0.197572158049E-03 0.200285688720E-03 0.203033351405E-03
3665+ 0.205815575433E-03 0.208632795530E-03 0.211485451894E-03 0.214373990257E-03
3666+ 0.217298861961E-03 0.220260524021E-03 0.223259439204E-03 0.226296076097E-03
3667+ 0.229370909179E-03 0.232484418901E-03 0.235637091753E-03 0.238829420349E-03
3668+ 0.242061903494E-03 0.245335046273E-03 0.248649360119E-03 0.252005362901E-03
3669+ 0.255403579002E-03 0.258844539399E-03 0.262328781750E-03 0.265856850474E-03
3670+ 0.269429296840E-03 0.273046679050E-03 0.276709562326E-03 0.280418519002E-03
3671+ 0.284174128610E-03 0.287976977971E-03 0.291827661289E-03 0.295726780240E-03
3672+ 0.299674944070E-03 0.303672769687E-03 0.307720881760E-03 0.311819912815E-03
3673+ 0.315970503333E-03 0.320173301853E-03 0.324428965070E-03 0.328738157941E-03
3674+ 0.333101553786E-03 0.337519834394E-03 0.341993690130E-03 0.346523820044E-03
3675+ 0.351110931978E-03 0.355755742677E-03 0.360458977902E-03 0.365221372543E-03
3676+ 0.370043670734E-03 0.374926625970E-03 0.379871001222E-03 0.384877569058E-03
3677+ 0.389947111764E-03 0.395080421469E-03 0.400278300260E-03 0.405541560318E-03
3678+ 0.410871024038E-03 0.416267524159E-03 0.421731903895E-03 0.427265017066E-03
3679+ 0.432867728234E-03 0.438540912832E-03 0.444285457309E-03 0.450102259259E-03
3680+ 0.455992227571E-03 0.461956282564E-03 0.467995356133E-03 0.474110391897E-03
3681+ 0.480302345342E-03 0.486572183973E-03 0.492920887465E-03 0.499349447817E-03
3682+ 0.505858869504E-03 0.512450169636E-03 0.519124378117E-03 0.525882537806E-03
3683+ 0.532725704679E-03 0.539654947995E-03 0.546671350463E-03 0.553776008409E-03
3684+ 0.560970031950E-03 0.568254545168E-03 0.575630686283E-03 0.583099607831E-03
3685+ 0.590662476846E-03 0.598320475044E-03 0.606074799000E-03 0.613926660345E-03
3686+ 0.621877285947E-03 0.629927918108E-03 0.638079814755E-03 0.646334249639E-03
3687+ 0.654692512533E-03 0.663155909431E-03 0.671725762757E-03 0.680403411567E-03
3688+ 0.689190211763E-03 0.698087536299E-03 0.707096775401E-03 0.716219336780E-03
3689+ 0.725456645856E-03 0.734810145976E-03 0.744281298644E-03 0.753871583746E-03
3690+ 0.763582499785E-03 0.773415564111E-03 0.783372313160E-03 0.793454302695E-03
3691+ 0.803663108046E-03 0.814000324361E-03 0.824467566850E-03 0.835066471041E-03
3692+ 0.845798693035E-03 0.856665909764E-03 0.867669819251E-03 0.878812140880E-03
3693+ 0.890094615663E-03 0.901519006507E-03 0.913087098498E-03 0.924800699174E-03
3694+ 0.936661638807E-03 0.948671770696E-03 0.960832971446E-03 0.973147141270E-03
3695+ 0.985616204283E-03 0.998242108801E-03 0.101102682765E-02 0.102397235846E-02
3696+ 0.103708072400E-02 0.105035397249E-02 0.106379417788E-02 0.107740344025E-02
3697+ 0.109118388607E-02 0.110513766856E-02 0.111926696802E-02 0.113357399219E-02
3698+ 0.114806097657E-02 0.116273018478E-02 0.117758390892E-02 0.119262446991E-02
3699+ 0.120785421786E-02 0.122327553246E-02 0.123889082332E-02 0.125470253036E-02
3700+ 0.127071312418E-02 0.128692510649E-02 0.130334101043E-02 0.131996340102E-02
3701+ 0.133679487555E-02 0.135383806396E-02 0.137109562929E-02 0.138857026807E-02
3702+ 0.140626471074E-02 0.142418172211E-02 0.144232410174E-02 0.146069468440E-02
3703+ 0.147929634055E-02 0.149813197673E-02 0.151720453605E-02 0.153651699863E-02
3704+ 0.155607238208E-02 0.157587374198E-02 0.159592417232E-02 0.161622680603E-02
3705+ 0.163678481543E-02 0.165760141275E-02 0.167867985063E-02 0.170002342263E-02
3706+ 0.172163546370E-02 0.174351935079E-02 0.176567850329E-02 0.178811638361E-02
3707+ 0.181083649773E-02 0.183384239569E-02 0.185713767223E-02 0.188072596727E-02
3708+ 0.190461096654E-02 0.192879640211E-02 0.195328605301E-02 0.197808374579E-02
3709+ 0.200319335515E-02 0.202861880451E-02 0.205436406664E-02 0.208043316431E-02
3710+ 0.210683017086E-02 0.213355921087E-02 0.216062446082E-02 0.218803014969E-02
3711+ 0.221578055969E-02 0.224388002687E-02 0.227233294184E-02 0.230114375041E-02
3712+ 0.233031695434E-02 0.235985711199E-02 0.238976883908E-02 0.242005680938E-02
3713+ 0.245072575543E-02 0.248178046933E-02 0.251322580344E-02 0.254506667114E-02
3714+ 0.257730804766E-02 0.260995497075E-02 0.264301254158E-02 0.267648592545E-02
3715+ 0.271038035265E-02 0.274470111924E-02 0.277945358792E-02 0.281464318884E-02
3716+ 0.285027542043E-02 0.288635585030E-02 0.292289011610E-02 0.295988392637E-02
3717+ 0.299734306148E-02 0.303527337448E-02 0.307368079207E-02 0.311257131547E-02
3718+ 0.315195102142E-02 0.319182606307E-02 0.323220267097E-02 0.327308715405E-02
3719+ 0.331448590060E-02 0.335640537924E-02 0.339885213997E-02 0.344183281520E-02
3720+ 0.348535412073E-02 0.352942285685E-02 0.357404590939E-02 0.361923025080E-02
3721+ 0.366498294120E-02 0.371131112956E-02 0.375822205473E-02 0.380572304664E-02
3722+ 0.385382152742E-02 0.390252501254E-02 0.395184111203E-02 0.400177753160E-02
3723+ 0.405234207394E-02 0.410354263983E-02 0.415538722948E-02 0.420788394369E-02
3724+ 0.426104098517E-02 0.431486665982E-02 0.436936937799E-02 0.442455765585E-02
3725+ 0.448044011665E-02 0.453702549214E-02 0.459432262390E-02 0.465234046468E-02
3726+ 0.471108807991E-02 0.477057464899E-02 0.483080946681E-02 0.489180194516E-02
3727+ 0.495356161424E-02 0.501609812410E-02 0.507942124617E-02 0.514354087482E-02
3728+ 0.520846702883E-02 0.527420985303E-02 0.534077961985E-02 0.540818673093E-02
3729+ 0.547644171874E-02 0.554555524823E-02 0.561553811851E-02 0.568640126451E-02
3730+ 0.575815575871E-02 0.583081281285E-02 0.590438377972E-02 0.597888015489E-02
3731+ 0.605431357853E-02 0.613069583721E-02 0.620803886578E-02 0.628635474919E-02
3732+ 0.636565572440E-02 0.644595418230E-02 0.652726266961E-02 0.660959389090E-02
3733+ 0.669296071051E-02 0.677737615461E-02 0.686285341319E-02 0.694940584219E-02
3734+ 0.703704696549E-02 0.712579047711E-02 0.721565024330E-02 0.730664030474E-02
3735+ 0.739877487867E-02 0.749206836121E-02 0.758653532951E-02 0.768219054409E-02
3736+ 0.777904895114E-02 0.787712568481E-02 0.797643606964E-02 0.807699562289E-02
3737+ 0.817882005702E-02 0.828192528209E-02 0.838632740830E-02 0.849204274846E-02
3738+ 0.859908782057E-02 0.870747935038E-02 0.881723427403E-02 0.892836974063E-02
3739+ 0.904090311504E-02 0.915485198049E-02 0.927023414137E-02 0.938706762600E-02
3740+ 0.950537068946E-02 0.962516181641E-02 0.974645972402E-02 0.986928336485E-02
3741+ 0.999365192983E-02 0.101195848513E-01 0.102471018058E-01 0.103762227177E-01
3742+ 0.105069677617E-01 0.106393573662E-01 0.107734122166E-01 0.109091532586E-01
3743+ 0.110466017010E-01 0.111857790196E-01 0.113267069601E-01 0.114694075418E-01
3744+ 0.116139030610E-01 0.117602160941E-01 0.119083695017E-01 0.120583864316E-01
3745+ 0.122102903231E-01 0.123641049098E-01 0.125198542241E-01 0.126775626004E-01
3746+ 0.128372546792E-01 0.129989554108E-01 0.131626900593E-01 0.133284842064E-01
3747+ 0.134963637554E-01 0.136663549355E-01 0.138384843055E-01 0.140127787582E-01
3748+ 0.141892655246E-01 0.143679721779E-01 0.145489266381E-01 0.147321571761E-01
3749+ 0.149176924183E-01 0.151055613509E-01 0.152957933247E-01 0.154884180590E-01
3750+ 0.156834656472E-01 0.158809665606E-01 0.160809516537E-01 0.162834521687E-01
3751+ 0.164884997404E-01 0.166961264014E-01 0.169063645867E-01 0.171192471389E-01
3752+ 0.173348073134E-01 0.175530787834E-01 0.177740956451E-01 0.179978924234E-01
3753+ 0.182245040765E-01 0.184539660023E-01 0.186863140428E-01 0.189215844906E-01
3754+ 0.191598140940E-01 0.194010400629E-01 0.196453000743E-01 0.198926322786E-01
3755+ 0.201430753049E-01 0.203966682675E-01 0.206534507717E-01 0.209134629198E-01
3756+ 0.211767453177E-01 0.214433390805E-01 0.217132858395E-01 0.219866277483E-01
3757+ 0.222634074892E-01 0.225436682800E-01 0.228274538804E-01 0.231148085989E-01
3758+ 0.234057772996E-01 0.237004054087E-01 0.239987389220E-01 0.243008244117E-01
3759+ 0.246067090332E-01 0.249164405328E-01 0.252300672547E-01 0.255476381484E-01
3760+ 0.258692027759E-01 0.261948113198E-01 0.265245145903E-01 0.268583640332E-01
3761+ 0.271964117375E-01 0.275387104433E-01 0.278853135500E-01 0.282362751237E-01
3762+ 0.285916499058E-01 0.289514933213E-01 0.293158614863E-01 0.296848112171E-01
3763+ 0.300584000385E-01 0.304366861919E-01 0.308197286441E-01 0.312075870964E-01
3764+ 0.316003219925E-01 0.319979945282E-01 0.324006666594E-01 0.328084011121E-01
3765+ 0.332212613905E-01 0.336393117867E-01 0.340626173899E-01 0.344912440953E-01
3766+ 0.349252586136E-01 0.353647284808E-01 0.358097220671E-01 0.362603085865E-01
3767+ 0.367165581070E-01 0.371785415594E-01 0.376463307475E-01 0.381199983579E-01
3768+ 0.385996179695E-01 0.390852640633E-01 0.395770120327E-01 0.400749381928E-01
3769+ 0.405791197908E-01 0.410896350158E-01 0.416065630084E-01 0.421299838713E-01
3770+ 0.426599786784E-01 0.431966294857E-01 0.437400193403E-01 0.442902322908E-01
3771+ 0.448473533971E-01 0.454114687399E-01 0.459826654308E-01 0.465610316217E-01
3772+ 0.471466565143E-01 0.477396303698E-01 0.483400445180E-01 0.489479913665E-01
3773+ 0.495635644100E-01 0.501868582388E-01 0.508179685479E-01 0.514569921449E-01
3774+ 0.521040269589E-01 0.527591720478E-01 0.534225276064E-01 0.540941949737E-01
3775+ 0.547742766396E-01 0.554628762521E-01 0.561600986231E-01 0.568660497340E-01
3776+ 0.575808367416E-01 0.583045679824E-01 0.590373529770E-01 0.597793024333E-01
3777+ 0.605305282499E-01 0.612911435182E-01 0.620612625236E-01 0.628410007459E-01
3778+ 0.636304748596E-01 0.644298027322E-01 0.652391034219E-01 0.660584971741E-01
3779+ 0.668881054170E-01 0.677280507558E-01 0.685784569649E-01 0.694394489795E-01
3780+ 0.703111528855E-01 0.711936959071E-01 0.720872063931E-01 0.729918138016E-01
3781+ 0.739076486818E-01 0.748348426540E-01 0.757735283880E-01 0.767238395775E-01
3782+ 0.776859109135E-01 0.786598780533E-01 0.796458775879E-01 0.806440470051E-01
3783+ 0.816545246501E-01 0.826774496814E-01 0.837129620240E-01 0.847612023176E-01
3784+ 0.858223118606E-01 0.868964325502E-01 0.879837068161E-01 0.890842775505E-01
3785+ 0.901982880314E-01 0.913258818403E-01 0.924672027742E-01 0.936223947498E-01
3786+ 0.947916017013E-01 0.959749674712E-01 0.971726356916E-01 0.983847496586E-01
3787+ 0.996114521969E-01 0.100852885515 0.102109191051 0.103380509305
3788+ 0.104666979667 0.105968740223 0.107285927558 0.108618676536
3789+ 0.109967120079 0.111331388916 0.112711611328 0.114107912869
3790+ 0.115520416074 0.116949240146 0.118394500622 0.119856309024
3791+ 0.121334772482 0.122829993334 0.124342068709 0.125871090073
3792+ 0.127417142759 0.128980305464 0.130560649712 0.132158239291
3793+ 0.133773129658 0.135405367303 0.137054989082 0.138722021509
3794+ 0.140406480007 0.142108368122 0.143827676685 0.145564382933
3795+ 0.147318449582 0.149089823842 0.150878436390 0.152684200279
3796+ 0.154507009788 0.156346739224 0.158203241643 0.160076347521
3797+ 0.161965863345 0.163871570145 0.165793221939 0.167730544113
3798+ 0.169683231713 0.171650947664 0.173633320893 0.175629944378
3799+ 0.177640373095 0.179664121879 0.181700663187 0.183749424768
3800+ 0.185809787228 0.187881081493 0.189962586175 0.192053524826
3801+ 0.194153063092 0.196260305749 0.198374293647 0.200494000529
3802+ 0.202618329758 0.204746110924 0.206876096359 0.209006957535
3803+ 0.211137281379 0.213265566479 0.215390219209 0.217509549764
3804+ 0.219621768124 0.221724979946 0.223817182402 0.225896259971
3805+ 0.227959980198 0.230005989435 0.232031808594 0.234034828903
3806+ 0.236012307730 0.237961364449 0.239878976430 0.241761975134
3807+ 0.243607042385 0.245410706835 0.247169340672 0.248879156611
3808+ 0.250536205225 0.252136372664 0.253675378817 0.255148775989
3809+ 0.256551948159 0.257880110878 0.259128311907 0.260291432667
3810+ 0.261364190586 0.262341142446 0.263216688831 0.263985079768
3811+ 0.264640421692 0.265176685834 0.265587718164 0.265867251002
3812+ 0.266008916441 0.266006261704 0.265852766573 0.265541863017
3813+ 0.265066957178 0.264421453817 0.263598783385 0.262592431819
3814+ 0.261395973201 0.260003105386 0.258407688691 0.256603787745
3815+ 0.254585716549 0.252348086799 0.249885859497 0.247194399811
3816+ 0.244269535168 0.241107616470 0.237705582299 0.234061025933
3817+ 0.230172264914 0.226038412870 0.221659453201 0.217036314164
3818+ 0.212170944824 0.207066391221 0.201726872026 0.196157852844
3819+ 0.190366118206 0.184359840199 0.178148642550 0.171743658842
3820+ 0.165157583466 0.158404713741 0.151500981553 0.144463972722
3821+ 0.137312932249 0.130068753437 0.122753948882 0.115392601204
3822+ 0.108010291417 0.100634002795 0.932919981577E-01 0.860136685494E-01
3823+ 0.788293514348E-01 0.717701167014E-01 0.648675190043E-01 0.581533153048E-01
3824+ 0.516591468470E-01 0.454161853016E-01 0.394547433898E-01 0.338038510069E-01
3825+ 0.284907986940E-01 0.235406512978E-01 0.189757358194E-01 0.148151088264E-01
3826+ 0.110740104262E-01 0.776331371326E-02 0.488898089234E-02 0.245153999591E-02
3827+ 0.445599388229E-03 -0.114057882306E-02 -0.232542059222E-02 -0.313426533012E-02
3828+ -0.359943628588E-02 -0.376010886481E-02 -0.366191961484E-02 -0.335624630023E-02
3829+ -0.289907471478E-02 -0.234935028276E-02 -0.176669166893E-02 -0.120831918000E-02
3830+ -0.725022326469E-03 -0.355958182956E-03 -0.122034814945E-03 -0.175916597414E-04
3831+ -0.408310256717E-07 0.00000000000 0.00000000000 0.00000000000
3832+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
3833+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
3834+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
3835+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
3836+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
3837+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
3838+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
3839+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
3840+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
3841+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
3842+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
3843+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
3844+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
3845+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
3846+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
3847+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
3848+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
3849+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
3850+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
3851+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
3852+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
3853+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
3854+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
3855+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
3856+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
3857+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
3858+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
3859+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
3860+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
3861+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
3862+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
3863+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
3864+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
3865+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
3866+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
3867+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
3868+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
3869+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
3870+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
3871+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
3872+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
3873+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
3874+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
3875+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
3876+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
3877+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
3878+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
3879+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
3880+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
3881+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
3882+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
3883+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
3884+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
3885+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
3886+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
3887+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
3888+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
3889+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
3890+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
3891+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
3892+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
3893+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
3894+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
3895+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
3896+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
3897+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
3898+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
3899+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
3900+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
3901+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
3902+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
3903+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
3904+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
3905+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
3906+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
3907+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
3908+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
3909+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
3910+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
3911+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
3912+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
3913+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
3914+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
3915+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
3916+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
3917+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
3918+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
3919+ Up Pseudopotential follows (l on next line)
3920+ 3
3921+ 0.178217031087E-07 0.358675756464E-07 0.541404373171E-07 0.726431432932E-07
3922+ 0.913785846596E-07 0.110349688867E-06 0.129559420190E-06 0.149010780187E-06
3923+ 0.168706808174E-06 0.188650581693E-06 0.208845217002E-06 0.229293869552E-06
3924+ 0.249999734488E-06 0.270966047142E-06 0.292196083544E-06 0.313693160930E-06
3925+ 0.335460638262E-06 0.357501916753E-06 0.379820440397E-06 0.402419696510E-06
3926+ 0.425303216270E-06 0.448474575275E-06 0.471937394096E-06 0.495695338846E-06
3927+ 0.519752121753E-06 0.544111501739E-06 0.568777285006E-06 0.593753325630E-06
3928+ 0.619043526172E-06 0.644651838277E-06 0.670582263293E-06 0.696838852905E-06
3929+ 0.723425709757E-06 0.750346988100E-06 0.777606894437E-06 0.805209688185E-06
3930+ 0.833159682336E-06 0.861461244135E-06 0.890118795756E-06 0.919136815003E-06
3931+ 0.948519835999E-06 0.978272449901E-06 0.100839930561E-05 0.103890511052E-05
3932+ 0.106979463122E-05 0.110107269425E-05 0.113274418689E-05 0.116481405786E-05
3933+ 0.119728731815E-05 0.123016904177E-05 0.126346436656E-05 0.129717849498E-05
3934+ 0.133131669492E-05 0.136588430056E-05 0.140088671316E-05 0.143632940190E-05
3935+ 0.147221790479E-05 0.150855782947E-05 0.154535485413E-05 0.158261472839E-05
3936+ 0.162034327416E-05 0.165854638663E-05 0.169723003509E-05 0.173640026395E-05
3937+ 0.177606319363E-05 0.181622502155E-05 0.185689202308E-05 0.189807055252E-05
3938+ 0.193976704409E-05 0.198198801297E-05 0.202474005625E-05 0.206802985404E-05
3939+ 0.211186417045E-05 0.215624985469E-05 0.220119384210E-05 0.224670315529E-05
3940+ 0.229278490516E-05 0.233944629209E-05 0.238669460702E-05 0.243453723258E-05
3941+ 0.248298164430E-05 0.253203541170E-05 0.258170619953E-05 0.263200176896E-05
3942+ 0.268292997877E-05 0.273449878661E-05 0.278671625019E-05 0.283959052861E-05
3943+ 0.289312988358E-05 0.294734268073E-05 0.300223739092E-05 0.305782259157E-05
3944+ 0.311410696796E-05 0.317109931466E-05 0.322880853683E-05 0.328724365165E-05
3945+ 0.334641378974E-05 0.340632819653E-05 0.346699623379E-05 0.352842738102E-05
3946+ 0.359063123696E-05 0.365361752108E-05 0.371739607513E-05 0.378197686462E-05
3947+ 0.384736998045E-05 0.391358564042E-05 0.398063419086E-05 0.404852610823E-05
3948+ 0.411727200080E-05 0.418688261026E-05 0.425736881338E-05 0.432874162380E-05
3949+ 0.440101219365E-05 0.447419181537E-05 0.454829192342E-05 0.462332409607E-05
3950+ 0.469930005728E-05 0.477623167844E-05 0.485413098026E-05 0.493301013467E-05
3951+ 0.501288146671E-05 0.509375745643E-05 0.517565074087E-05 0.525857411601E-05
3952+ 0.534254053881E-05 0.542756312919E-05 0.551365517210E-05 0.560083011960E-05
3953+ 0.568910159296E-05 0.577848338476E-05 0.586898946110E-05 0.596063396375E-05
3954+ 0.605343121231E-05 0.614739570658E-05 0.624254212870E-05 0.633888534545E-05
3955+ 0.643644041071E-05 0.653522256761E-05 0.663524725110E-05 0.673653009021E-05
3956+ 0.683908691061E-05 0.694293373701E-05 0.704808679568E-05 0.715456251700E-05
3957+ 0.726237753802E-05 0.737154870506E-05 0.748209307634E-05 0.759402792463E-05
3958+ 0.770737073999E-05 0.782213923246E-05 0.793835133484E-05 0.805602520553E-05
3959+ 0.817517923129E-05 0.829583203021E-05 0.841800245448E-05 0.854170959354E-05
3960+ 0.866697277686E-05 0.879381157703E-05 0.892224581292E-05 0.905229555261E-05
3961+ 0.918398111666E-05 0.931732308121E-05 0.945234228118E-05 0.958905981361E-05
3962+ 0.972749704092E-05 0.986767559417E-05 0.100096173765E-04 0.101533445668E-04
3963+ 0.102988796225E-04 0.104462452839E-04 0.105954645770E-04 0.107465608179E-04
3964+ 0.108995576155E-04 0.110544788759E-04 0.112113488058E-04 0.113701919166E-04
3965+ 0.115310330277E-04 0.116938972710E-04 0.118588100942E-04 0.120257972654E-04
3966+ 0.121948848767E-04 0.123660993483E-04 0.125394674328E-04 0.127150162193E-04
3967+ 0.128927731378E-04 0.130727659630E-04 0.132550228193E-04 0.134395721846E-04
3968+ 0.136264428952E-04 0.138156641499E-04 0.140072655150E-04 0.142012769286E-04
3969+ 0.143977287054E-04 0.145966515413E-04 0.147980765185E-04 0.150020351100E-04
3970+ 0.152085591848E-04 0.154176810126E-04 0.156294332692E-04 0.158438490413E-04
3971+ 0.160609618318E-04 0.162808055650E-04 0.165034145919E-04 0.167288236957E-04
3972+ 0.169570680970E-04 0.171881834595E-04 0.174222058953E-04 0.176591719710E-04
3973+ 0.178991187130E-04 0.181420836135E-04 0.183881046361E-04 0.186372202223E-04
3974+ 0.188894692969E-04 0.191448912741E-04 0.194035260644E-04 0.196654140798E-04
3975+ 0.199305962409E-04 0.201991139830E-04 0.204710092625E-04 0.207463245636E-04
3976+ 0.210251029049E-04 0.213073878461E-04 0.215932234947E-04 0.218826545131E-04
3977+ 0.221757261256E-04 0.224724841252E-04 0.227729748808E-04 0.230772453449E-04
3978+ 0.233853430603E-04 0.236973161678E-04 0.240132134140E-04 0.243330841583E-04
3979+ 0.246569783814E-04 0.249849466922E-04 0.253170403365E-04 0.256533112047E-04
3980+ 0.259938118397E-04 0.263385954453E-04 0.266877158949E-04 0.270412277391E-04
3981+ 0.273991862150E-04 0.277616472541E-04 0.281286674919E-04 0.285003042760E-04
3982+ 0.288766156753E-04 0.292576604893E-04 0.296434982571E-04 0.300341892665E-04
3983+ 0.304297945638E-04 0.308303759633E-04 0.312359960565E-04 0.316467182223E-04
3984+ 0.320626066369E-04 0.324837262839E-04 0.329101429639E-04 0.333419233055E-04
3985+ 0.337791347752E-04 0.342218456882E-04 0.346701252189E-04 0.351240434120E-04
3986+ 0.355836711930E-04 0.360490803798E-04 0.365203436937E-04 0.369975347701E-04
3987+ 0.374807281715E-04 0.379699993976E-04 0.384654248982E-04 0.389670820843E-04
3988+ 0.394750493411E-04 0.399894060394E-04 0.405102325485E-04 0.410376102486E-04
3989+ 0.415716215436E-04 0.421123498738E-04 0.426598797290E-04 0.432142966620E-04
3990+ 0.437756873015E-04 0.443441393661E-04 0.449197416774E-04 0.455025841744E-04
3991+ 0.460927579274E-04 0.466903551524E-04 0.472954692253E-04 0.479081946961E-04
3992+ 0.485286273046E-04 0.491568639946E-04 0.497930029294E-04 0.504371435069E-04
3993+ 0.510893863755E-04 0.517498334493E-04 0.524185879247E-04 0.530957542958E-04
3994+ 0.537814383713E-04 0.544757472908E-04 0.551787895413E-04 0.558906749748E-04
3995+ 0.566115148246E-04 0.573414217235E-04 0.580805097212E-04 0.588288943012E-04
3996+ 0.595866924004E-04 0.603540224264E-04 0.611310042759E-04 0.619177593540E-04
3997+ 0.627144105925E-04 0.635210824702E-04 0.643379010310E-04 0.651649939043E-04
3998+ 0.660024903255E-04 0.668505211547E-04 0.677092188986E-04 0.685787177304E-04
3999+ 0.694591535112E-04 0.703506638108E-04 0.712533879295E-04 0.721674669197E-04
4000+ 0.730930436083E-04 0.740302626184E-04 0.749792703925E-04 0.759402152147E-04
4001+ 0.769132472349E-04 0.778985184911E-04 0.788961829342E-04 0.799063964510E-04
4002+ 0.809293168896E-04 0.819651040834E-04 0.830139198762E-04 0.840759281476E-04
4003+ 0.851512948388E-04 0.862401879774E-04 0.873427777059E-04 0.884592363059E-04
4004+ 0.895897382261E-04 0.907344601100E-04 0.918935808224E-04 0.930672814789E-04
4005+ 0.942557454720E-04 0.954591585020E-04 0.966777086044E-04 0.979115861802E-04
4006+ 0.991609840251E-04 0.100426097360E-03 0.101707123863E-03 0.103004263695E-03
4007+ 0.104317719537E-03 0.105647696620E-03 0.106994402755E-03 0.108358048368E-03
4008+ 0.109738846532E-03 0.111137012998E-03 0.112552766233E-03 0.113986327452E-03
4009+ 0.115437920651E-03 0.116907772645E-03 0.118396113101E-03 0.119903174575E-03
4010+ 0.121429192549E-03 0.122974405466E-03 0.124539054769E-03 0.126123384937E-03
4011+ 0.127727643526E-03 0.129352081203E-03 0.130996951791E-03 0.132662512304E-03
4012+ 0.134349022989E-03 0.136056747367E-03 0.137785952273E-03 0.139536907900E-03
4013+ 0.141309887837E-03 0.143105169116E-03 0.144923032254E-03 0.146763761294E-03
4014+ 0.148627643856E-03 0.150514971175E-03 0.152426038148E-03 0.154361143385E-03
4015+ 0.156320589250E-03 0.158304681909E-03 0.160313731381E-03 0.162348051585E-03
4016+ 0.164407960387E-03 0.166493779652E-03 0.168605835293E-03 0.170744457324E-03
4017+ 0.172909979909E-03 0.175102741414E-03 0.177323084463E-03 0.179571355990E-03
4018+ 0.181847907291E-03 0.184153094083E-03 0.186487276554E-03 0.188850819427E-03
4019+ 0.191244092009E-03 0.193667468254E-03 0.196121326820E-03 0.198606051126E-03
4020+ 0.201122029417E-03 0.203669654819E-03 0.206249325403E-03 0.208861444248E-03
4021+ 0.211506419504E-03 0.214184664452E-03 0.216896597575E-03 0.219642642616E-03
4022+ 0.222423228652E-03 0.225238790155E-03 0.228089767061E-03 0.230976604842E-03
4023+ 0.233899754571E-03 0.236859672998E-03 0.239856822614E-03 0.242891671732E-03
4024+ 0.245964694551E-03 0.249076371240E-03 0.252227188002E-03 0.255417637159E-03
4025+ 0.258648217226E-03 0.261919432988E-03 0.265231795578E-03 0.268585822560E-03
4026+ 0.271982038007E-03 0.275420972585E-03 0.278903163634E-03 0.282429155254E-03
4027+ 0.285999498387E-03 0.289614750908E-03 0.293275477707E-03 0.296982250779E-03
4028+ 0.300735649317E-03 0.304536259794E-03 0.308384676065E-03 0.312281499453E-03
4029+ 0.316227338843E-03 0.320222810782E-03 0.324268539570E-03 0.328365157359E-03
4030+ 0.332513304255E-03 0.336713628415E-03 0.340966786146E-03 0.345273442013E-03
4031+ 0.349634268942E-03 0.354049948318E-03 0.358521170100E-03 0.363048632927E-03
4032+ 0.367633044222E-03 0.372275120311E-03 0.376975586525E-03 0.381735177323E-03
4033+ 0.386554636400E-03 0.391434716804E-03 0.396376181061E-03 0.401379801282E-03
4034+ 0.406446359294E-03 0.411576646754E-03 0.416771465282E-03 0.422031626579E-03
4035+ 0.427357952553E-03 0.432751275455E-03 0.438212438001E-03 0.443742293509E-03
4036+ 0.449341706029E-03 0.455011550479E-03 0.460752712787E-03 0.466566090018E-03
4037+ 0.472452590522E-03 0.478413134078E-03 0.484448652032E-03 0.490560087445E-03
4038+ 0.496748395240E-03 0.503014542353E-03 0.509359507879E-03 0.515784283233E-03
4039+ 0.522289872297E-03 0.528877291582E-03 0.535547570384E-03 0.542301750945E-03
4040+ 0.549140888620E-03 0.556066052037E-03 0.563078323262E-03 0.570178797979E-03
4041+ 0.577368585647E-03 0.584648809685E-03 0.592020607639E-03 0.599485131366E-03
4042+ 0.607043547211E-03 0.614697036189E-03 0.622446794171E-03 0.630294032068E-03
4043+ 0.638239976027E-03 0.646285867611E-03 0.654432964007E-03 0.662682538209E-03
4044+ 0.671035879227E-03 0.679494292284E-03 0.688059099019E-03 0.696731637696E-03
4045+ 0.705513263412E-03 0.714405348309E-03 0.723409281789E-03 0.732526470725E-03
4046+ 0.741758339692E-03 0.751106331184E-03 0.760571905833E-03 0.770156542647E-03
4047+ 0.779861739240E-03 0.789689012057E-03 0.799639896620E-03 0.809715947768E-03
4048+ 0.819918739890E-03 0.830249867184E-03 0.840710943900E-03 0.851303604585E-03
4049+ 0.862029504354E-03 0.872890319135E-03 0.883887745937E-03 0.895023503115E-03
4050+ 0.906299330636E-03 0.917716990353E-03 0.929278266277E-03 0.940984964862E-03
4051+ 0.952838915280E-03 0.964841969712E-03 0.976996003636E-03 0.989302916115E-03
4052+ 0.100176463010E-02 0.101438309273E-02 0.102716027564E-02 0.104009817525E-02
4053+ 0.105319881309E-02 0.106646423613E-02 0.107989651708E-02 0.109349775471E-02
4054+ 0.110727007420E-02 0.112121562745E-02 0.113533659343E-02 0.114963517851E-02
4055+ 0.116411361682E-02 0.117877417056E-02 0.119361913043E-02 0.120865081590E-02
4056+ 0.122387157562E-02 0.123928378779E-02 0.125488986051E-02 0.127069223216E-02
4057+ 0.128669337180E-02 0.130289577954E-02 0.131930198691E-02 0.133591455731E-02
4058+ 0.135273608634E-02 0.136976920229E-02 0.138701656645E-02 0.140448087361E-02
4059+ 0.142216485244E-02 0.144007126592E-02 0.145820291178E-02 0.147656262293E-02
4060+ 0.149515326790E-02 0.151397775130E-02 0.153303901423E-02 0.155234003483E-02
4061+ 0.157188382862E-02 0.159167344910E-02 0.161171198811E-02 0.163200257639E-02
4062+ 0.165254838405E-02 0.167335262103E-02 0.169441853765E-02 0.171574942508E-02
4063+ 0.173734861587E-02 0.175921948445E-02 0.178136544770E-02 0.180378996543E-02
4064+ 0.182649654093E-02 0.184948872156E-02 0.187277009923E-02 0.189634431101E-02
4065+ 0.192021503970E-02 0.194438601434E-02 0.196886101089E-02 0.199364385271E-02
4066+ 0.201873841124E-02 0.204414860654E-02 0.206987840794E-02 0.209593183463E-02
4067+ 0.212231295630E-02 0.214902589378E-02 0.217607481962E-02 0.220346395882E-02
4068+ 0.223119758943E-02 0.225928004324E-02 0.228771570642E-02 0.231650902022E-02
4069+ 0.234566448167E-02 0.237518664422E-02 0.240508011853E-02 0.243534957308E-02
4070+ 0.246599973500E-02 0.249703539069E-02 0.252846138663E-02 0.256028263011E-02
4071+ 0.259250408997E-02 0.262513079737E-02 0.265816784658E-02 0.269162039573E-02
4072+ 0.272549366764E-02 0.275979295055E-02 0.279452359903E-02 0.282969103471E-02
4073+ 0.286530074716E-02 0.290135829469E-02 0.293786930522E-02 0.297483947714E-02
4074+ 0.301227458016E-02 0.305018045616E-02 0.308856302016E-02 0.312742826109E-02
4075+ 0.316678224281E-02 0.320663110495E-02 0.324698106387E-02 0.328783841355E-02
4076+ 0.332920952658E-02 0.337110085508E-02 0.341351893167E-02 0.345647037046E-02
4077+ 0.349996186798E-02 0.354400020422E-02 0.358859224360E-02 0.363374493599E-02
4078+ 0.367946531772E-02 0.372576051262E-02 0.377263773303E-02 0.382010428087E-02
4079+ 0.386816754869E-02 0.391683502070E-02 0.396611427387E-02 0.401601297902E-02
4080+ 0.406653890188E-02 0.411769990417E-02 0.416950394474E-02 0.422195908064E-02
4081+ 0.427507346829E-02 0.432885536452E-02 0.438331312776E-02 0.443845521916E-02
4082+ 0.449429020369E-02 0.455082675133E-02 0.460807363820E-02 0.466603974767E-02
4083+ 0.472473407158E-02 0.478416571134E-02 0.484434387910E-02 0.490527789889E-02
4084+ 0.496697720780E-02 0.502945135711E-02 0.509271001346E-02 0.515676295996E-02
4085+ 0.522162009737E-02 0.528729144518E-02 0.535378714282E-02 0.542111745067E-02
4086+ 0.548929275126E-02 0.555832355031E-02 0.562822047781E-02 0.569899428912E-02
4087+ 0.577065586598E-02 0.584321621753E-02 0.591668648133E-02 0.599107792433E-02
4088+ 0.606640194382E-02 0.614267006833E-02 0.621989395852E-02 0.629808540804E-02
4089+ 0.637725634430E-02 0.645741882927E-02 0.653858506013E-02 0.662076737001E-02
4090+ 0.670397822850E-02 0.678823024225E-02 0.687353615542E-02 0.695990885007E-02
4091+ 0.704736134648E-02 0.713590680339E-02 0.722555851812E-02 0.731632992666E-02
4092+ 0.740823460357E-02 0.750128626178E-02 0.759549875238E-02 0.769088606407E-02
4093+ 0.778746232271E-02 0.788524179051E-02 0.798423886519E-02 0.808446807892E-02
4094+ 0.818594409706E-02 0.828868171678E-02 0.839269586534E-02 0.849800159827E-02
4095+ 0.860461409722E-02 0.871254866765E-02 0.882182073610E-02 0.893244584732E-02
4096+ 0.904443966102E-02 0.915781794824E-02 0.927259658748E-02 0.938879156035E-02
4097+ 0.950641894688E-02 0.962549492037E-02 0.974603574182E-02 0.986805775385E-02
4098+ 0.999157737410E-02 0.101166110881E-01 0.102431754417E-01 0.103712870325E-01
4099+ 0.105009625009E-01 0.106322185208E-01 0.107650717887E-01 0.108995390130E-01
4100+ 0.110356369013E-01 0.111733821484E-01 0.113127914217E-01 0.114538813468E-01
4101+ 0.115966684916E-01 0.117411693493E-01 0.118874003200E-01 0.120353776920E-01
4102+ 0.121851176204E-01 0.123366361054E-01 0.124899489686E-01 0.126450718281E-01
4103+ 0.128020200715E-01 0.129608088276E-01 0.131214529360E-01 0.132839669149E-01
4104+ 0.134483649270E-01 0.136146607424E-01 0.137828677007E-01 0.139529986694E-01
4105+ 0.141250660002E-01 0.142990814831E-01 0.144750562969E-01 0.146530009570E-01
4106+ 0.148329252609E-01 0.150148382290E-01 0.151987480431E-01 0.153846619808E-01
4107+ 0.155725863462E-01 0.157625263966E-01 0.159544862651E-01 0.161484688785E-01
4108+ 0.163444758715E-01 0.165425074944E-01 0.167425625179E-01 0.169446381307E-01
4109+ 0.171487298328E-01 0.173548313227E-01 0.175629343784E-01 0.177730287322E-01
4110+ 0.179851019394E-01 0.181991392395E-01 0.184151234111E-01 0.186330346185E-01
4111+ 0.188528502517E-01 0.190745447577E-01 0.192980894642E-01 0.195234523942E-01
4112+ 0.197505980727E-01 0.199794873233E-01 0.202100770564E-01 0.204423200476E-01
4113+ 0.206761647061E-01 0.209115548333E-01 0.211484293707E-01 0.213867221383E-01
4114+ 0.216263615611E-01 0.218672703858E-01 0.221093653859E-01 0.223525570566E-01
4115+ 0.225967492976E-01 0.228418390857E-01 0.230877161364E-01 0.233342625538E-01
4116+ 0.235813524705E-01 0.238288516774E-01 0.240766172422E-01 0.243244971196E-01
4117+ 0.245723297512E-01 0.248199436579E-01 0.250671570237E-01 0.253137772733E-01
4118+ 0.255596006439E-01 0.258044117520E-01 0.260479831571E-01 0.262900749248E-01
4119+ 0.265304341882E-01 0.267687947136E-01 0.270048764687E-01 0.272383851991E-01
4120+ 0.274690120133E-01 0.276964329816E-01 0.279203087496E-01 0.281402841727E-01
4121+ 0.283559879731E-01 0.285670324258E-01 0.287730130764E-01 0.289735084972E-01
4122+ 0.291680800870E-01 0.293562719189E-01 0.295376106448E-01 0.297116054616E-01
4123+ 0.298777481467E-01 0.300355131707E-01 0.301843578951E-01 0.303237228632E-01
4124+ 0.304530321931E-01 0.305716940824E-01 0.306791014330E-01 0.307746326073E-01
4125+ 0.308576523241E-01 0.309275127060E-01 0.309835544872E-01 0.310251083925E-01
4126+ 0.310514966988E-01 0.310620349867E-01 0.310560340943E-01 0.310328022804E-01
4127+ 0.309916476074E-01 0.309318805497E-01 0.308528168356E-01 0.307537805276E-01
4128+ 0.306341073445E-01 0.304931482279E-01 0.303302731528E-01 0.301448751802E-01
4129+ 0.299363747458E-01 0.297042241783E-01 0.294479124352E-01 0.291669700407E-01
4130+ 0.288609742095E-01 0.285295541301E-01 0.281723963842E-01 0.277892504674E-01
4131+ 0.273799343775E-01 0.269443402259E-01 0.264824398287E-01 0.259942902251E-01
4132+ 0.254800390670E-01 0.249399298212E-01 0.243743067192E-01 0.237836193879E-01
4133+ 0.231684270920E-01 0.225294025171E-01 0.218673350224E-01 0.211831332928E-01
4134+ 0.204778273244E-01 0.197525696792E-01 0.190086359547E-01 0.182474244210E-01
4135+ 0.174704547881E-01 0.166793660811E-01 0.158759136161E-01 0.150619650844E-01
4136+ 0.142394957755E-01 0.134105829857E-01 0.125773996820E-01 0.117422075102E-01
4137+ 0.109073492551E-01 0.100752408755E-01 0.924836324842E-02 0.842925376110E-02
4138+ 0.762049788405E-02 0.682472084345E-02 0.604457948149E-02 0.528275434642E-02
4139+ 0.454194199024E-02 0.382484736516E-02 0.313417610183E-02 0.247262632018E-02
4140+ 0.184287946942E-02 0.124758951876E-02 0.689369630615E-03 0.170775249842E-03
4141+ -0.305717651047E-03 -0.737740606001E-03 -0.112306853833E-02 -0.145966513069E-02
4142+ -0.174573928962E-02 -0.197981414505E-02 -0.216080967533E-02 -0.228813946531E-02
4143+ -0.236182123440E-02 -0.238259955224E-02 -0.235207753255E-02 -0.227285220134E-02
4144+ -0.214864561644E-02 -0.198442062302E-02 -0.178646631855E-02 -0.156243383432E-02
4145+ -0.132129787998E-02 -0.107321359491E-02 -0.829231526641E-03 -0.600825874699E-03
4146+ -0.399182260066E-03 -0.234180818698E-03 -0.112997786914E-03 -0.382331200675E-04
4147+ -0.468415811383E-05 -0.264578606643E-08 0.00000000000 0.00000000000
4148+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
4149+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
4150+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
4151+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
4152+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
4153+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
4154+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
4155+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
4156+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
4157+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
4158+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
4159+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
4160+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
4161+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
4162+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
4163+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
4164+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
4165+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
4166+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
4167+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
4168+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
4169+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
4170+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
4171+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
4172+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
4173+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
4174+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
4175+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
4176+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
4177+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
4178+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
4179+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
4180+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
4181+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
4182+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
4183+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
4184+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
4185+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
4186+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
4187+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
4188+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
4189+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
4190+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
4191+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
4192+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
4193+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
4194+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
4195+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
4196+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
4197+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
4198+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
4199+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
4200+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
4201+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
4202+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
4203+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
4204+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
4205+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
4206+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
4207+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
4208+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
4209+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
4210+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
4211+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
4212+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
4213+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
4214+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
4215+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
4216+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
4217+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
4218+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
4219+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
4220+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
4221+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
4222+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
4223+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
4224+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
4225+ Core charge follows
4226+ 0.813563583454E-10 0.329531653420E-09 0.750821344721E-09 0.135170632987E-08
4227+ 0.213885796690E-08 0.311914322777E-08 0.429962998661E-08 0.568759244593E-08
4228+ 0.729051670461E-08 0.911610647109E-08 0.111722889256E-07 0.134672207354E-07
4229+ 0.160092942263E-07 0.188071437158E-07 0.218696520102E-07 0.252059570717E-07
4230+ 0.288254588585E-07 0.327378263431E-07 0.369530047130E-07 0.414812227585E-07
4231+ 0.463330004527E-07 0.515191567286E-07 0.570508174575E-07 0.629394236354E-07
4232+ 0.691967397811E-07 0.758348625526E-07 0.828662295871E-07 0.903036285701E-07
4233+ 0.981602065389E-07 0.106449479429E-06 0.115185341865E-06 0.124382077208E-06
4234+ 0.134054367861E-06 0.144217305844E-06 0.154886403636E-06 0.166077605307E-06
4235+ 0.177807297929E-06 0.190092323290E-06 0.202949989903E-06 0.216398085330E-06
4236+ 0.230454888826E-06 0.245139184303E-06 0.260470273635E-06 0.276467990304E-06
4237+ 0.293152713399E-06 0.310545381973E-06 0.328667509775E-06 0.347541200361E-06
4238+ 0.367189162588E-06 0.387634726520E-06 0.408901859730E-06 0.431015184034E-06
4239+ 0.453999992646E-06 0.477882267783E-06 0.502688698720E-06 0.528446700305E-06
4240+ 0.555184431959E-06 0.582930817163E-06 0.611715563437E-06 0.641569182848E-06
4241+ 0.672523013032E-06 0.704609238764E-06 0.737860914082E-06 0.772311984974E-06
4242+ 0.807997312657E-06 0.844952697444E-06 0.883214903232E-06 0.922821682617E-06
4243+ 0.963811802649E-06 0.100622507125E-05 0.105010236433E-05 0.109548565356E-05
4244+ 0.114241803487E-05 0.119094375772E-05 0.124110825506E-05 0.129295817412E-05
4245+ 0.134654140789E-05 0.140190712756E-05 0.145910581564E-05 0.151818930001E-05
4246+ 0.157921078883E-05 0.164222490636E-05 0.170728772964E-05 0.177445682618E-05
4247+ 0.184379129254E-05 0.191535179402E-05 0.198920060518E-05 0.206540165161E-05
4248+ 0.214402055257E-05 0.222512466490E-05 0.230878312788E-05 0.239506690941E-05
4249+ 0.248404885323E-05 0.257580372742E-05 0.267040827413E-05 0.276794126057E-05
4250+ 0.286848353132E-05 0.297211806197E-05 0.307893001408E-05 0.318900679168E-05
4251+ 0.330243809905E-05 0.341931600009E-05 0.353973497917E-05 0.366379200352E-05
4252+ 0.379158658724E-05 0.392322085692E-05 0.405879961897E-05 0.419843042864E-05
4253+ 0.434222366078E-05 0.449029258250E-05 0.464275342754E-05 0.479972547272E-05
4254+ 0.496133111612E-05 0.512769595751E-05 0.529894888056E-05 0.547522213741E-05
4255+ 0.565665143518E-05 0.584337602483E-05 0.603553879223E-05 0.623328635153E-05
4256+ 0.643676914098E-05 0.664614152111E-05 0.686156187551E-05 0.708319271407E-05
4257+ 0.731120077895E-05 0.754575715315E-05 0.778703737201E-05 0.803522153731E-05
4258+ 0.829049443455E-05 0.855304565298E-05 0.882306970884E-05 0.910076617169E-05
4259+ 0.938633979394E-05 0.968000064372E-05 0.998196424110E-05 0.102924516978E-04
4260+ 0.106116898604E-04 0.109399114574E-04 0.112773552496E-04 0.116242661850E-04
4261+ 0.119808955566E-04 0.123475011656E-04 0.127243474873E-04 0.131117058424E-04
4262+ 0.135098545719E-04 0.139190792170E-04 0.143396727030E-04 0.147719355283E-04
4263+ 0.152161759582E-04 0.156727102235E-04 0.161418627240E-04 0.166239662375E-04
4264+ 0.171193621342E-04 0.176284005958E-04 0.181514408412E-04 0.186888513572E-04
4265+ 0.192410101352E-04 0.198083049143E-04 0.203911334302E-04 0.209899036706E-04
4266+ 0.216050341367E-04 0.222369541123E-04 0.228861039385E-04 0.235529352963E-04
4267+ 0.242379114963E-04 0.249415077750E-04 0.256642115997E-04 0.264065229806E-04
4268+ 0.271689547904E-04 0.279520330930E-04 0.287562974798E-04 0.295823014151E-04
4269+ 0.304306125892E-04 0.313018132824E-04 0.321965007360E-04 0.331152875344E-04
4270+ 0.340588019963E-04 0.350276885756E-04 0.360226082731E-04 0.370442390580E-04
4271+ 0.380932763005E-04 0.391704332154E-04 0.402764413169E-04 0.414120508845E-04
4272+ 0.425780314419E-04 0.437751722466E-04 0.450042827929E-04 0.462661933278E-04
4273+ 0.475617553789E-04 0.488918422970E-04 0.502573498117E-04 0.516591966014E-04
4274+ 0.530983248774E-04 0.545757009837E-04 0.560923160105E-04 0.576491864255E-04
4275+ 0.592473547185E-04 0.608878900651E-04 0.625718890051E-04 0.643004761393E-04
4276+ 0.660748048437E-04 0.678960580015E-04 0.697654487545E-04 0.716842212723E-04
4277+ 0.736536515425E-04 0.756750481797E-04 0.777497532557E-04 0.798791431508E-04
4278+ 0.820646294260E-04 0.843076597184E-04 0.866097186585E-04 0.889723288111E-04
4279+ 0.913970516400E-04 0.938854884969E-04 0.964392816363E-04 0.990601152549E-04
4280+ 0.101749716559E-03 0.104509856855E-03 0.107342352676E-03 0.110249066926E-03
4281+ 0.113231910062E-03 0.116292841300E-03 0.119433869859E-03 0.122657056226E-03
4282+ 0.125964513462E-03 0.129358408541E-03 0.132840963713E-03 0.136414457914E-03
4283+ 0.140081228205E-03 0.143843671250E-03 0.147704244827E-03 0.151665469384E-03
4284+ 0.155729929630E-03 0.159900276165E-03 0.164179227160E-03 0.168569570068E-03
4285+ 0.173074163383E-03 0.177695938451E-03 0.182437901312E-03 0.187303134604E-03
4286+ 0.192294799504E-03 0.197416137724E-03 0.202670473557E-03 0.208061215970E-03
4287+ 0.213591860761E-03 0.219265992757E-03 0.225087288078E-03 0.231059516454E-03
4288+ 0.237186543601E-03 0.243472333658E-03 0.249920951689E-03 0.256536566238E-03
4289+ 0.263323451962E-03 0.270285992322E-03 0.277428682343E-03 0.284756131451E-03
4290+ 0.292273066372E-03 0.299984334107E-03 0.307894904993E-03 0.316009875824E-03
4291+ 0.324334473066E-03 0.332874056144E-03 0.341634120819E-03 0.350620302644E-03
4292+ 0.359838380515E-03 0.369294280305E-03 0.378994078595E-03 0.388944006497E-03
4293+ 0.399150453573E-03 0.409619971859E-03 0.420359279983E-03 0.431375267394E-03
4294+ 0.442674998691E-03 0.454265718072E-03 0.466154853886E-03 0.478350023305E-03
4295+ 0.490859037113E-03 0.503689904618E-03 0.516850838686E-03 0.530350260906E-03
4296+ 0.544196806880E-03 0.558399331654E-03 0.572966915282E-03 0.587908868534E-03
4297+ 0.603234738743E-03 0.618954315808E-03 0.635077638341E-03 0.651614999980E-03
4298+ 0.668576955849E-03 0.685974329192E-03 0.703818218171E-03 0.722120002836E-03
4299+ 0.740891352273E-03 0.760144231929E-03 0.779890911132E-03 0.800143970790E-03
4300+ 0.820916311291E-03 0.842221160603E-03 0.864072082581E-03 0.886482985477E-03
4301+ 0.909468130674E-03 0.933042141635E-03 0.957220013084E-03 0.982017120415E-03
4302+ 0.100744922934E-02 0.103353250579E-02 0.106028352605E-02 0.108771928715E-02
4303+ 0.111585721756E-02 0.114471518810E-02 0.117431152315E-02 0.120466501216E-02
4304+ 0.123579492144E-02 0.126772100620E-02 0.130046352301E-02 0.133404324244E-02
4305+ 0.136848146213E-02 0.140380002013E-02 0.144002130858E-02 0.147716828777E-02
4306+ 0.151526450053E-02 0.155433408700E-02 0.159440179975E-02 0.163549301929E-02
4307+ 0.167763377001E-02 0.172085073645E-02 0.176517128009E-02 0.181062345643E-02
4308+ 0.185723603261E-02 0.190503850543E-02 0.195406111985E-02 0.200433488792E-02
4309+ 0.205589160823E-02 0.210876388582E-02 0.216298515261E-02 0.221858968836E-02
4310+ 0.227561264214E-02 0.233409005434E-02 0.239405887925E-02 0.245555700821E-02
4311+ 0.251862329336E-02 0.258329757194E-02 0.264962069125E-02 0.271763453428E-02
4312+ 0.278738204584E-02 0.285890725957E-02 0.293225532541E-02 0.300747253793E-02
4313+ 0.308460636529E-02 0.316370547898E-02 0.324481978428E-02 0.332800045149E-02
4314+ 0.341329994796E-02 0.350077207098E-02 0.359047198138E-02 0.368245623811E-02
4315+ 0.377678283363E-02 0.387351123018E-02 0.397270239699E-02 0.407441884847E-02
4316+ 0.417872468331E-02 0.428568562455E-02 0.439536906075E-02 0.450784408814E-02
4317+ 0.462318155382E-02 0.474145410011E-02 0.486273620997E-02 0.498710425361E-02
4318+ 0.511463653623E-02 0.524541334701E-02 0.537951700933E-02 0.551703193224E-02
4319+ 0.565804466322E-02 0.580264394237E-02 0.595092075781E-02 0.610296840262E-02
4320+ 0.625888253314E-02 0.641876122879E-02 0.658270505336E-02 0.675081711787E-02
4321+ 0.692320314505E-02 0.709997153536E-02 0.728123343477E-02 0.746710280422E-02
4322+ 0.765769649082E-02 0.785313430084E-02 0.805353907459E-02 0.825903676317E-02
4323+ 0.846975650711E-02 0.868583071708E-02 0.890739515658E-02 0.913458902670E-02
4324+ 0.936755505313E-02 0.960643957521E-02 0.985139263733E-02 0.101025680827E-01
4325+ 0.103601236491E-01 0.106242210679E-01 0.108950261645E-01 0.111727089620E-01
4326+ 0.114574437873E-01 0.117494093801E-01 0.120487890042E-01 0.123557705617E-01
4327+ 0.126705467108E-01 0.129933149854E-01 0.133242779185E-01 0.136636431688E-01
4328+ 0.140116236498E-01 0.143684376628E-01 0.147343090329E-01 0.151094672488E-01
4329+ 0.154941476055E-01 0.158885913512E-01 0.162930458377E-01 0.167077646744E-01
4330+ 0.171330078863E-01 0.175690420762E-01 0.180161405907E-01 0.184745836905E-01
4331+ 0.189446587246E-01 0.194266603100E-01 0.199208905143E-01 0.204276590445E-01
4332+ 0.209472834391E-01 0.214800892663E-01 0.220264103264E-01 0.225865888593E-01
4333+ 0.231609757579E-01 0.237499307857E-01 0.243538228013E-01 0.249730299871E-01
4334+ 0.256079400848E-01 0.262589506365E-01 0.269264692315E-01 0.276109137598E-01
4335+ 0.283127126716E-01 0.290323052435E-01 0.297701418513E-01 0.305266842499E-01
4336+ 0.313024058596E-01 0.320977920602E-01 0.329133404921E-01 0.337495613651E-01
4337+ 0.346069777749E-01 0.354861260277E-01 0.363875559723E-01 0.373118313412E-01
4338+ 0.382595301003E-01 0.392312448063E-01 0.402275829742E-01 0.412491674537E-01
4339+ 0.422966368143E-01 0.433706457409E-01 0.444718654390E-01 0.456009840495E-01
4340+ 0.467587070747E-01 0.479457578142E-01 0.491628778121E-01 0.504108273153E-01
4341+ 0.516903857425E-01 0.530023521663E-01 0.543475458059E-01 0.557268065326E-01
4342+ 0.571409953884E-01 0.585909951160E-01 0.600777107041E-01 0.616020699438E-01
4343+ 0.631650240012E-01 0.647675480020E-01 0.664106416324E-01 0.680953297536E-01
4344+ 0.698226630323E-01 0.715937185861E-01 0.734096006459E-01 0.752714412332E-01
4345+ 0.771804008555E-01 0.791376692181E-01 0.811444659535E-01 0.832020413691E-01
4346+ 0.853116772130E-01 0.874746874585E-01 0.896924191085E-01 0.919662530191E-01
4347+ 0.942976047434E-01 0.966879253966E-01 0.991387025412E-01 0.101651461095
4348+ 0.104227764262 0.106869214481 0.109577454406 0.112354167903
4349+ 0.115201081075 0.118119963309 0.121112628352 0.124180935412
4350+ 0.127326790282 0.130552146498 0.133859006518 0.137249422935
4351+ 0.140725499717 0.144289393476 0.147943314769 0.151689529431
4352+ 0.155530359938 0.159468186802 0.163505450003 0.167644650454
4353+ 0.171888351498 0.176239180444 0.180699830137 0.185273060571
4354+ 0.189961700531 0.194768649280 0.199696878289 0.204749432996
4355+ 0.209929434621 0.215240082012 0.220684653542 0.226266509046
4356+ 0.231989091801 0.237855930563 0.243870641636 0.250036931002
4357+ 0.256358596495 0.262839530020 0.269483719835 0.276295252874
4358+ 0.283278317130 0.290437204089 0.297776311221 0.305300144526
4359+ 0.313013321139 0.320920571994 0.329026744544 0.337336805548
4360+ 0.345855843916 0.354589073616 0.363541836650 0.372719606088
4361+ 0.382127989182 0.391772730530 0.401659715324 0.411794972660
4362+ 0.422184678923 0.432835161242 0.443752901021 0.454944537543
4363+ 0.466416871654 0.478176869514 0.490231666441 0.502588570824
4364+ 0.515255068117 0.528238824922 0.541547693146 0.555189714249
4365+ 0.569173123572 0.583506354755 0.598198044235 0.613257035844
4366+ 0.628692385484 0.644513365897 0.660729471527 0.677350423469
4367+ 0.694386174513 0.711846914284 0.729743074466 0.748085334130
4368+ 0.766884625153 0.786152137727 0.805899325968 0.826137913626
4369+ 0.846879899875 0.868137565214 0.889923477455 0.912250497807
4370+ 0.935131787058 0.958580811849 0.982611351040 1.00723750217
4371+ 1.03247368802 1.05833466323 1.08483552107 1.11199170022
4372+ 1.13981899170 1.16833354586 1.19755187943 1.22749088269
4373+ 1.25816782670 1.28960037057 1.32180656885 1.35480487898
4374+ 1.38861416875 1.42325372386 1.45874325554 1.49510290820
4375+ 1.53235326710 1.57051536612 1.60961069545 1.64966120943
4376+ 1.69068933430 1.73271797601 1.77577052800 1.81987087898
4377+ 1.86504342067 1.91131305556 1.95870520449 2.00724581436
4378+ 2.05696136559 2.10787887964 2.16002592629 2.21343063092
4379+ 2.26812168159 2.32412833598 2.38148042820 2.44020837531
4380+ 2.50034318375 2.56191645546 2.62496039375 2.68950780888
4381+ 2.75559212338 2.82324737697 2.89250823117 2.96340997342
4382+ 3.03598852091 3.11028042381 3.18632286808 3.26415367771
4383+ 3.34381131640 3.42533488859 3.50876413988 3.59413945666
4384+ 3.68150186509 3.77089302916 3.86235524797 3.95593145208
4385+ 4.05166519886 4.14960066683 4.24978264889 4.35225654445
4386+ 4.45706835021 4.56426464980 4.67389260188 4.78599992693
4387+ 4.90063489246 5.01784629656 5.13768344983 5.26019615546
4388+ 5.38543468750 5.51344976708 5.64429253656 5.77801453159
4389+ 5.91466765076 6.05430412297 6.19697647218 6.34273747963
4390+ 6.49164014328 6.64373763437 6.79908325097 6.95773036848
4391+ 7.11973238677 7.28514267401 7.45401450689 7.62640100724
4392+ 7.80235507477 7.98192931583 8.16517596811 8.35214682104
4393+ 8.54289313170 8.73746553625 8.93591395657 9.13828750199
4394+ 9.34463436599 9.55500171769 9.76943558796 9.98798075003
4395+ 10.2106805944 10.4375769980 10.6687101871 10.9041185947
4396+ 11.1438387110 11.3879049278 11.6363493765 11.8892017594
4397+ 12.1464891740 12.4082359309 12.6744633648 12.9451896378
4398+ 13.2204295369 13.5001942632 13.7844912149 14.0733237630
4399+ 14.3666910195 14.6645875995 14.9670033756 15.2739232255
4400+ 15.5853267739 15.9011881267 16.2214755994 16.5461514398
4401+ 16.8751715448 17.2084851710 17.5460346415 17.8877550478
4402+ 18.2335739465 18.5834110545 18.9371779391 19.2947777075
4403+ 19.6561046943 20.0210441476 20.3894719164 20.7612541382
4404+ 21.1362469297 21.5142960799 21.8952367485 22.2788931694
4405+ 22.6650783620 23.0535938511 23.4442293966 23.8367627357
4406+ 24.2309593385 24.6265721790 25.0233415240 25.4209947413
4407+ 25.8192461294 26.2177967719 26.6163344170 27.0145333865
4408+ 27.4120545159 27.8085451281 28.2036390428 28.5969566261
4409+ 28.9881048811 29.3766775831 29.7622554622 30.1444064360
4410+ 30.5226858955 30.8966370461 31.2657913078 31.6296687760
4411+ 31.9877787461 32.3396203044 32.6846829877 33.0224475136
4412+ 33.3523865832 33.6739657590 33.9866444184 34.2898767847
4413+ 34.5831130367 34.8658004968 35.1373848980 35.3973117304
4414+ 35.6450276654 35.8799820566 36.1016285165 36.3094265658
4415+ 36.5028433525 36.6813554379 36.8444506444 36.9916299610
4416+ 37.1224095004 37.2363225014 37.3329213699 37.4117797501
4417+ 37.4724946176 37.5146883855 37.5380110123 37.5421421020
4418+ 37.5267929845 37.4917087640 37.4366703227 37.3614962676
4419+ 37.2660448047 37.1502155293 37.0139511154 36.8572388916
4420+ 36.6801122886 36.4826521426 36.2649878428 36.0272983066
4421+ 35.7698127710 35.4928113865 35.1966256024 34.8816383314
4422+ 34.5482838865 34.1970476786 33.8284656708 33.4431235833
4423+ 33.0416558456 32.6247442962 32.1931166284 31.7475445891
4424+ 31.2888419333 30.8178621438 30.3354959278 29.8426685029
4425+ 29.3403366880 28.8294858202 28.3111265166 27.7862913066
4426+ 27.2560311601 26.7214119413 26.1835108181 25.6434126617
4427+ 25.1022064691 24.5609818480 24.0208256007 23.4828184476
4428+ 22.9480319310 22.4175255421 21.8923441145 21.3735155285
4429+ 20.8620487725 20.3589324078 19.8651334865 19.3811796804
4430+ 18.9059624928 18.4380873284 17.9763069867 17.5195226456
4431+ 17.0667832930 16.6172837130 16.1703611387 15.7254906905
4432+ 15.2822797241 14.8404612154 14.3998863119 13.9605161828
4433+ 13.5224132971 13.0857322600 12.6507103324 12.2176577559
4434+ 11.7869479990 11.3590080324 10.9343087378 10.5133555404
4435+ 10.0966793522 9.68482789870 9.27835749781 8.87782534197
4436+ 8.48378233315 8.09676650607 7.71729706635 7.34586906197
4437+ 6.98294869765 6.62896929382 6.28432788466 5.94938244233
4438+ 5.62444971090 5.30980362242 5.00567427068 4.71224740838
4439+ 4.42966443236 4.15802281910 3.89737697023 3.64773942638
4440+ 3.40908241027 3.18133965095 2.96440845363 2.75815197117
4441+ 2.56240163800 2.37695972851 2.20160200366 2.03608041178
4442+ 1.88012581182 1.73345068992 1.59575184257 1.46671300276
4443+ 1.34600738764 1.23330014959 1.12825071478 1.03051499608
4444+ 0.939747469954 0.855603108908 0.777739163769 0.705816791963
4445+ 0.639502530006 0.578469610219 0.522399123296 0.470981029816
4446+ 0.423915025061 0.380911262601 0.341690943060 0.305986775222
4447+ 0.273543317262 0.244117206352 0.217477285210 0.193404634360
4448+ 0.171692518929 0.152146258809 0.134583030835 0.118831611459
4449+ 0.104732068083 0.921354068799E-01 0.809031845174E-01 0.709070907763E-01
4450+ 0.620285085680E-01 0.541580573775E-01 0.471951256463E-01 0.410473971106E-01
4451+ 0.356303755994E-01 0.308669123055E-01 0.266867390598E-01 0.230260106727E-01
4452+ 0.198268589684E-01 0.170369607149E-01 0.146091212634E-01 0.125008753446E-01
4453+ 0.106741061355E-01 0.909468340042E-02 0.773212123447E-02 0.655925568851E-02
4454+ 0.555194233143E-02 0.468877361378E-02 0.395081572693E-02 0.332136450962E-02
4455+ 0.278571983204E-02 0.233097779005E-02 0.194583996248E-02 0.162043892396E-02
4456+ 0.134617916286E-02 0.111559252332E-02 0.922207276653E-03 0.760429922310E-03
4457+ 0.625438825496E-03 0.513088813997E-03 0.419825878497E-03 0.342611150287E-03
4458+ 0.278853362944E-03 0.226349042308E-03 0.183229709151E-03 0.147915420683E-03
4459+ 0.119074020513E-03 0.955855099509E-04 0.765109970082E-04 0.610657221562E-04
4460+ 0.485957013603E-04 0.385575670812E-04 0.305012262347E-04 0.240549905047E-04
4461+ 0.189128687129E-04 0.148237430271E-04 0.115821806463E-04 0.902066018219E-05
4462+ 0.700301730031E-05 0.541893734405E-05 0.417934370426E-05 0.321254971904E-05
4463+ 0.246105899107E-05 0.187891431187E-05 0.142950900558E-05 0.108378657318E-05
4464+ 0.818765158646E-06 0.616332695334E-06 0.462266744094E-06 0.345440122686E-06
4465+ 0.257179557803E-06 0.190749871834E-06 0.140940743063E-06 0.103736940211E-06
4466+ 0.760562123297E-07 0.555417879291E-07 0.403987704074E-07 0.292656709867E-07
4467+ 0.211139493564E-07 0.151697838554E-07 0.108534092283E-07 0.773227741683E-08
4468+ 0.548504732624E-08 0.387402046690E-08 0.272413437900E-08 0.190702485669E-08
4469+ 0.132898821860E-08 0.921930551550E-09 0.636593990328E-09 0.437510685367E-09
4470+ 0.299261428663E-09 0.203714770399E-09 0.137999439336E-09 0.930225164342E-10
4471+ 0.623917731178E-10 0.416358249882E-10 0.276426287364E-10 0.182572409560E-10
4472+ 0.119951454632E-10 0.783900588080E-11 0.509532288049E-11 0.329387749962E-11
4473+ 0.211756905349E-11 0.135372715118E-11 0.860511670010E-12 0.543854514137E-12
4474+ 0.341725177038E-12 0.213455348138E-12 0.132537912467E-12 0.817980730649E-13
4475+ 0.501744201893E-13 0.305861008054E-13 0.185282367547E-13 0.111526400509E-13
4476+ 0.666990925693E-14 0.396301272154E-14 0.233915277508E-14 0.137146012425E-14
4477+ 0.798661531509E-15 0.461913277108E-15 0.265301027918E-15 0.151307525452E-15
4478+ 0.856815111126E-16 0.481703893300E-16 0.268844199265E-16 0.148939276786E-16
4479+ 0.818966237983E-17 0.446920848007E-17 0.242026149161E-17 0.130052814025E-17
4480+ 0.693363924641E-18 0.366728362591E-18 0.192409613421E-18 0.100130128370E-18
4481+ 0.516790741261E-19 0.264504033268E-19 0.134237123019E-19 0.675445524656E-20
4482+ 0.336929793145E-20 0.166599376503E-20 0.816479156162E-21 0.396558197672E-21
4483+ 0.190858101792E-21 0.910138006694E-22 0.429979178048E-22 0.201224592333E-22
4484+ 0.932733250324E-23 0.428178961067E-23 0.194640275753E-23 0.876046263076E-24
4485+ 0.390350815088E-24 0.172172181666E-24 0.751616288482E-25 0.324712863277E-25
4486+ 0.138808813673E-25 0.587073239122E-26 0.245622410034E-26 0.101645050751E-26
4487+ 0.415995294896E-27 0.168350814693E-27 0.673607066065E-28 0.266441537723E-28
4488+ 0.104169283929E-28 0.402492436964E-29 0.153671452090E-29 0.579672229621E-30
4489+ 0.216003754989E-30 0.794995297471E-31 0.288952520291E-31 0.103700431587E-31
4490+ 0.367417246100E-32 0.128497719214E-32 0.443526407842E-33 0.151064448066E-33
4491+ 0.507637361662E-34 0.168276117370E-34 0.550170526110E-35 0.177380428599E-35
4492+ 0.563864177798E-36 0.176697293629E-36 0.545754498703E-37 0.166112195927E-37
4493+ 0.498157321241E-38 0.147168768101E-38 0.428224558117E-39 0.122703300367E-39
4494+ 0.346171262813E-40 0.961383038767E-41 0.262780150151E-41 0.706804147888E-42
4495+ 0.187040020182E-42 0.486875476964E-43 0.124642883265E-43 0.313761833267E-44
4496+ 0.776483422028E-45 0.188877230780E-45 0.451500030107E-46 0.106042918795E-46
4497+ 0.244661591961E-47 0.554401344799E-48 0.123359003343E-48 0.269475280169E-49
4498+ 0.577805421628E-50 0.121582681734E-50 0.251016251653E-51 0.508375220126E-52
4499+ 0.100979114966E-52 0.196677885397E-53 0.375550503693E-54 0.702881415678E-55
4500+ 0.128916569447E-55 0.231665061842E-56 0.407802374751E-57 0.703054253013E-58
4501+ 0.118683548788E-58 0.196140743343E-59 0.317273714141E-60 0.502230571313E-61
4502+ 0.777838170754E-62 0.117843934985E-62 0.174611376422E-63 0.252988784796E-64
4503+ 0.358352386953E-65 0.496154938427E-66 0.671337478965E-67 0.887565804351E-68
4504+ 0.114634909535E-68 0.144614407828E-69 0.178158863813E-70 0.214303183511E-71
4505+ 0.251652111883E-72 0.288436465830E-73 0.322630728265E-74 0.352125258264E-75
4506+ 0.374935071635E-76 0.389417675668E-77 0.394467313289E-78 0.389653952103E-79
4507+ 0.375282861550E-80 0.352363459731E-81 0.322491664134E-82 0.287664848831E-83
4508+ 0.250059413172E-84 0.211805622320E-85 0.174792093459E-86 0.140524076982E-87
4509+ 0.110047844354E-88 0.839409674281E-90 0.623577569449E-91 0.451124388899E-92
4510+ 0.317804209086E-93 0.217997671719E-94 0.145595174332E-95 0.946717241597E-97
4511+ 0.599304659836E-98 0.00000000000 0.00000000000 0.00000000000
4512+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
4513+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
4514+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
4515+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
4516+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
4517+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
4518+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
4519+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
4520+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
4521+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
4522+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
4523+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
4524+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
4525+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
4526+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
4527+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
4528+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
4529+ 0.00000000000 0.00000000000 0.00000000000 0.00000000000
4530+ Valence charge follows
4531+ 0.465279041133E-14 0.188459973929E-13 0.429396598429E-13 0.773044219125E-13
4532+ 0.122321820231E-12 0.178384578640E-12 0.245896910622E-12 0.325274829635E-12
4533+ 0.416946467543E-12 0.521352401357E-12 0.638945988494E-12 0.770193710789E-12
4534+ 0.915575527459E-12 0.107558523727E-11 0.125073085015E-11 0.144153496844E-11
4535+ 0.164853517810E-11 0.187228445009E-11 0.211335155216E-11 0.237232147141E-11
4536+ 0.264979584774E-11 0.294639341864E-11 0.326275047547E-11 0.359952133168E-11
4537+ 0.395737880305E-11 0.433701470049E-11 0.473914033561E-11 0.516448703934E-11
4538+ 0.561380669409E-11 0.608787227958E-11 0.658747843292E-11 0.711344202314E-11
4539+ 0.766660274060E-11 0.824782370165E-11 0.885799206898E-11 0.949801968793E-11
4540+ 0.101688437394E-10 0.108714274094E-10 0.116067605762E-10 0.123758605151E-10
4541+ 0.131797726212E-10 0.140195711512E-10 0.148963599844E-10 0.158112734026E-10
4542+ 0.167654768910E-10 0.177601679595E-10 0.187965769849E-10 0.198759680752E-10
4543+ 0.209996399558E-10 0.221689268790E-10 0.233851995566E-10 0.246498661165E-10
4544+ 0.259643730842E-10 0.273302063894E-10 0.287488923986E-10 0.302219989741E-10
4545+ 0.317511365606E-10 0.333379592993E-10 0.349841661712E-10 0.366915021693E-10
4546+ 0.384617595012E-10 0.402967788227E-10 0.421984505029E-10 0.441687159218E-10
4547+ 0.462095688015E-10 0.483230565715E-10 0.505112817688E-10 0.527764034743E-10
4548+ 0.551206387860E-10 0.575462643298E-10 0.600556178096E-10 0.626510995961E-10
4549+ 0.653351743581E-10 0.681103727338E-10 0.709792930461E-10 0.739446030619E-10
4550+ 0.770090417956E-10 0.801754213600E-10 0.834466288637E-10 0.868256283578E-10
4551+ 0.903154628319E-10 0.939192562619E-10 0.976402157097E-10 0.101481633477E-09
4552+ 0.105446889313E-09 0.109539452682E-09 0.113762885086E-09 0.118120842445E-09
4553+ 0.122617077545E-09 0.127255442542E-09 0.132039891531E-09 0.136974483188E-09
4554+ 0.142063383466E-09 0.147310868374E-09 0.152721326817E-09 0.158299263517E-09
4555+ 0.164049301997E-09 0.169976187656E-09 0.176084790911E-09 0.182380110422E-09
4556+ 0.188867276406E-09 0.195551554023E-09 0.202438346865E-09 0.209533200516E-09
4557+ 0.216841806219E-09 0.224370004626E-09 0.232123789646E-09 0.240109312399E-09
4558+ 0.248332885258E-09 0.256800986003E-09 0.265520262081E-09 0.274497534971E-09
4559+ 0.283739804659E-09 0.293254254236E-09 0.303048254603E-09 0.313129369302E-09
4560+ 0.323505359471E-09 0.334184188917E-09 0.345174029333E-09 0.356483265631E-09
4561+ 0.368120501428E-09 0.380094564656E-09 0.392414513327E-09 0.405089641441E-09
4562+ 0.418129485040E-09 0.431543828424E-09 0.445342710522E-09 0.459536431422E-09
4563+ 0.474135559074E-09 0.489150936159E-09 0.504593687134E-09 0.520475225459E-09
4564+ 0.536807261004E-09 0.553601807646E-09 0.570871191063E-09 0.588628056723E-09
4565+ 0.606885378074E-09 0.625656464951E-09 0.644954972188E-09 0.664794908454E-09
4566+ 0.685190645313E-09 0.706156926517E-09 0.727708877528E-09 0.749862015294E-09
4567+ 0.772632258263E-09 0.796035936658E-09 0.820089803011E-09 0.844811042967E-09
4568+ 0.870217286362E-09 0.896326618581E-09 0.923157592208E-09 0.950729238971E-09
4569+ 0.979061081989E-09 0.100817314834E-08 0.103808598192E-08 0.106882065669E-08
4570+ 0.110039879017E-08 0.113284255737E-08 0.116617470501E-08 0.120041856611E-08
4571+ 0.123559807501E-08 0.127173778267E-08 0.130886287246E-08 0.134699917629E-08
4572+ 0.138617319114E-08 0.142641209609E-08 0.146774376968E-08 0.151019680780E-08
4573+ 0.155380054198E-08 0.159858505813E-08 0.164458121585E-08 0.169182066811E-08
4574+ 0.174033588152E-08 0.179016015707E-08 0.184132765142E-08 0.189387339870E-08
4575+ 0.194783333291E-08 0.200324431085E-08 0.206014413563E-08 0.211857158084E-08
4576+ 0.217856641524E-08 0.224016942814E-08 0.230342245543E-08 0.236836840622E-08
4577+ 0.243505129019E-08 0.250351624566E-08 0.257380956833E-08 0.264597874073E-08
4578+ 0.272007246251E-08 0.279614068140E-08 0.287423462501E-08 0.295440683345E-08
4579+ 0.303671119270E-08 0.312120296893E-08 0.320793884360E-08 0.329697694954E-08
4580+ 0.338837690787E-08 0.348219986588E-08 0.357850853588E-08 0.367736723508E-08
4581+ 0.377884192636E-08 0.388300026020E-08 0.398991161764E-08 0.409964715427E-08
4582+ 0.421227984539E-08 0.432788453237E-08 0.444653797002E-08 0.456831887538E-08
4583+ 0.469330797754E-08 0.482158806888E-08 0.495324405753E-08 0.508836302119E-08
4584+ 0.522703426229E-08 0.536934936456E-08 0.551540225110E-08 0.566528924378E-08
4585+ 0.581910912430E-08 0.597696319671E-08 0.613895535152E-08 0.630519213149E-08
4586+ 0.647578279902E-08 0.665083940530E-08 0.683047686120E-08 0.701481300993E-08
4587+ 0.720396870162E-08 0.739806786969E-08 0.759723760922E-08 0.780160825732E-08
4588+ 0.801131347550E-08 0.822649033411E-08 0.844727939903E-08 0.867382482041E-08
4589+ 0.890627442378E-08 0.914477980340E-08 0.938949641802E-08 0.964058368905E-08
4590+ 0.989820510121E-08 0.101625283058E-07 0.104337252263E-07 0.107119721674E-07
4591+ 0.109974499256E-07 0.112903439038E-07 0.115908442282E-07 0.118991458680E-07
4592+ 0.122154487585E-07 0.125399579276E-07 0.128728836243E-07 0.132144414523E-07
4593+ 0.135648525049E-07 0.139243435052E-07 0.142931469486E-07 0.146715012495E-07
4594+ 0.150596508917E-07 0.154578465820E-07 0.158663454088E-07 0.162854110036E-07
4595+ 0.167153137076E-07 0.171563307412E-07 0.176087463797E-07 0.180728521313E-07
4596+ 0.185489469215E-07 0.190373372809E-07 0.195383375383E-07 0.200522700186E-07
4597+ 0.205794652460E-07 0.211202621517E-07 0.216750082875E-07 0.222440600442E-07
4598+ 0.228277828766E-07 0.234265515326E-07 0.240407502898E-07 0.246707731968E-07
4599+ 0.253170243213E-07 0.259799180045E-07 0.266598791213E-07 0.273573433480E-07
4600+ 0.280727574360E-07 0.288065794930E-07 0.295592792713E-07 0.303313384625E-07
4601+ 0.311232510012E-07 0.319355233751E-07 0.327686749436E-07 0.336232382643E-07
4602+ 0.344997594279E-07 0.353987984010E-07 0.363209293790E-07 0.372667411460E-07
4603+ 0.382368374455E-07 0.392318373598E-07 0.402523756986E-07 0.412991033985E-07
4604+ 0.423726879315E-07 0.434738137249E-07 0.446031825907E-07 0.457615141673E-07
4605+ 0.469495463708E-07 0.481680358593E-07 0.494177585075E-07 0.506995098946E-07
4606+ 0.520141058038E-07 0.533623827348E-07 0.547451984290E-07 0.561634324080E-07
4607+ 0.576179865266E-07 0.591097855385E-07 0.606397776772E-07 0.622089352517E-07
4608+ 0.638182552565E-07 0.654687599979E-07 0.671614977359E-07 0.688975433421E-07
4609+ 0.706779989747E-07 0.725039947705E-07 0.743766895538E-07 0.762972715648E-07
4610+ 0.782669592045E-07 0.802870018002E-07 0.823586803893E-07 0.844833085235E-07
4611+ 0.866622330934E-07 0.888968351735E-07 0.911885308893E-07 0.935387723058E-07
4612+ 0.959490483393E-07 0.984208856910E-07 0.100955849806E-06 0.103555545855E-06
4613+ 0.106221619741E-06 0.108955759136E-06 0.111759694532E-06 0.114635200338E-06
4614+ 0.117584095982E-06 0.120608247060E-06 0.123709566507E-06 0.126890015790E-06
4615+ 0.130151606149E-06 0.133496399850E-06 0.136926511484E-06 0.140444109292E-06
4616+ 0.144051416526E-06 0.147750712844E-06 0.151544335740E-06 0.155434682011E-06
4617+ 0.159424209262E-06 0.163515437443E-06 0.167710950437E-06 0.172013397676E-06
4618+ 0.176425495808E-06 0.180950030395E-06 0.185589857669E-06 0.190347906315E-06
4619+ 0.195227179318E-06 0.200230755840E-06 0.205361793156E-06 0.210623528632E-06
4620+ 0.216019281760E-06 0.221552456240E-06 0.227226542114E-06 0.233045117956E-06
4621+ 0.239011853122E-06 0.245130510047E-06 0.251404946610E-06 0.257839118553E-06
4622+ 0.264437081966E-06 0.271202995830E-06 0.278141124629E-06 0.285255841027E-06
4623+ 0.292551628609E-06 0.300033084703E-06 0.307704923256E-06 0.315571977801E-06
4624+ 0.323639204489E-06 0.331911685199E-06 0.340394630729E-06 0.349093384071E-06
4625+ 0.358013423760E-06 0.367160367321E-06 0.376539974791E-06 0.386158152338E-06
4626+ 0.396020955972E-06 0.406134595348E-06 0.416505437664E-06 0.427140011663E-06
4627+ 0.438045011736E-06 0.449227302125E-06 0.460693921234E-06 0.472452086059E-06
4628+ 0.484509196716E-06 0.496872841094E-06 0.509550799626E-06 0.522551050178E-06
4629+ 0.535881773063E-06 0.549551356187E-06 0.563568400320E-06 0.577941724509E-06
4630+ 0.592680371618E-06 0.607793614020E-06 0.623290959430E-06 0.639182156884E-06
4631+ 0.655477202877E-06 0.672186347649E-06 0.689320101641E-06 0.706889242107E-06
4632+ 0.724904819900E-06 0.743378166435E-06 0.762320900816E-06 0.781744937162E-06
4633+ 0.801662492109E-06 0.822086092508E-06 0.843028583319E-06 0.864503135706E-06
4634+ 0.886523255345E-06 0.909102790931E-06 0.932255942922E-06 0.955997272489E-06
4635+ 0.980341710706E-06 0.100530456797E-05 0.103090154368E-05 0.105714873612E-05
4636+ 0.108406265265E-05 0.111166022012E-05 0.113995879558E-05 0.116897617724E-05
4637+ 0.119873061572E-05 0.122924082559E-05 0.126052599722E-05 0.129260580890E-05
4638+ 0.132550043934E-05 0.135923058039E-05 0.139381745019E-05 0.142928280658E-05
4639+ 0.146564896095E-05 0.150293879229E-05 0.154117576182E-05 0.158038392776E-05
4640+ 0.162058796070E-05 0.166181315922E-05 0.170408546597E-05 0.174743148418E-05
4641+ 0.179187849455E-05 0.183745447264E-05 0.188418810666E-05 0.193210881574E-05
4642+ 0.198124676871E-05 0.203163290331E-05 0.208329894593E-05 0.213627743188E-05
4643+ 0.219060172616E-05 0.224630604480E-05 0.230342547675E-05 0.236199600632E-05
4644+ 0.242205453626E-05 0.248363891138E-05 0.254678794287E-05 0.261154143319E-05
4645+ 0.267794020165E-05 0.274602611067E-05 0.281584209273E-05 0.288743217801E-05
4646+ 0.296084152280E-05 0.303611643866E-05 0.311330442231E-05 0.319245418640E-05
4647+ 0.327361569101E-05 0.335684017606E-05 0.344218019457E-05 0.352968964682E-05
4648+ 0.361942381537E-05 0.371143940116E-05 0.380579456042E-05 0.390254894270E-05
4649+ 0.400176372990E-05 0.410350167636E-05 0.420782715002E-05 0.431480617474E-05
4650+ 0.442450647380E-05 0.453699751450E-05 0.465235055416E-05 0.477063868719E-05
4651+ 0.489193689365E-05 0.501632208905E-05 0.514387317558E-05 0.527467109477E-05
4652+ 0.540879888167E-05 0.554634172047E-05 0.568738700183E-05 0.583202438171E-05
4653+ 0.598034584198E-05 0.613244575270E-05 0.628842093628E-05 0.644837073341E-05
4654+ 0.661239707097E-05 0.678060453190E-05 0.695310042714E-05 0.712999486969E-05
4655+ 0.731140085086E-05 0.749743431881E-05 0.768821425948E-05 0.788386277987E-05
4656+ 0.808450519400E-05 0.829027011135E-05 0.850128952812E-05 0.871769892131E-05
4657+ 0.893963734565E-05 0.916724753372E-05 0.940067599912E-05 0.964007314295E-05
4658+ 0.988559336377E-05 0.101373951711E-04 0.103956413024E-04 0.106604988444E-04
4659+ 0.109321393581E-04 0.112107390076E-04 0.114964786942E-04 0.117895441942E-04
4660+ 0.120901263021E-04 0.123984209779E-04 0.127146295006E-04 0.130389586264E-04
4661+ 0.133716207527E-04 0.137128340882E-04 0.140628228289E-04 0.144218173406E-04
4662+ 0.147900543488E-04 0.151677771348E-04 0.155552357395E-04 0.159526871758E-04
4663+ 0.163603956479E-04 0.167786327807E-04 0.172076778566E-04 0.176478180636E-04
4664+ 0.180993487519E-04 0.185625737021E-04 0.190378054039E-04 0.195253653471E-04
4665+ 0.200255843240E-04 0.205388027461E-04 0.210653709732E-04 0.216056496582E-04
4666+ 0.221600101065E-04 0.227288346517E-04 0.233125170490E-04 0.239114628857E-04
4667+ 0.245260900118E-04 0.251568289907E-04 0.258041235709E-04 0.264684311815E-04
4668+ 0.271502234510E-04 0.278499867523E-04 0.285682227746E-04 0.293054491248E-04
4669+ 0.300621999587E-04 0.308390266461E-04 0.316364984696E-04 0.324552033610E-04
4670+ 0.332957486762E-04 0.341587620134E-04 0.350448920743E-04 0.359548095737E-04
4671+ 0.368892081992E-04 0.378488056255E-04 0.388343445853E-04 0.398465940021E-04
4672+ 0.408863501886E-04 0.419544381140E-04 0.430517127472E-04 0.441790604784E-04
4673+ 0.453374006267E-04 0.465276870379E-04 0.477509097799E-04 0.490080969418E-04
4674+ 0.503003165440E-04 0.516286785671E-04 0.529943371083E-04 0.543984926732E-04
4675+ 0.558423946132E-04 0.573273437194E-04 0.588546949827E-04 0.604258605328E-04
4676+ 0.620423127683E-04 0.637055876927E-04 0.654172884693E-04 0.671790892117E-04
4677+ 0.689927390270E-04 0.708600663294E-04 0.727829834439E-04 0.747634915208E-04
4678+ 0.768036857847E-04 0.789057611400E-04 0.810720181614E-04 0.833048694957E-04
4679+ 0.856068467055E-04 0.879806075870E-04 0.904289439969E-04 0.929547902251E-04
4680+ 0.955612319540E-04 0.982515158464E-04 0.101029059810E-03 0.103897463985E-03
4681+ 0.106860522515E-03 0.109922236147E-03 0.113086825738E-03 0.116358746717E-03
4682+ 0.119742704589E-03 0.123243671550E-03 0.126866904293E-03 0.130617963102E-03
4683+ 0.134502732324E-03 0.138527442315E-03 0.142698692987E-03 0.147023479051E-03
4684+ 0.151509217109E-03 0.156163774710E-03 0.160995501520E-03 0.166013262781E-03
4685+ 0.171226475202E-03 0.176645145487E-03 0.182279911678E-03 0.188142087531E-03
4686+ 0.194243710158E-03 0.200597591158E-03 0.207217371512E-03 0.214117580522E-03
4687+ 0.221313699085E-03 0.228822227634E-03 0.236660759079E-03 0.244848057144E-03
4688+ 0.253404140471E-03 0.262350372942E-03 0.271709560668E-03 0.281506056146E-03
4689+ 0.291765870108E-03 0.302516791646E-03 0.313788517202E-03 0.325612789108E-03
4690+ 0.338023544355E-03 0.351057074369E-03 0.364752196594E-03 0.379150438749E-03
4691+ 0.394296236713E-03 0.410237147017E-03 0.427024075040E-03 0.444711520047E-03
4692+ 0.463357838310E-03 0.483025525651E-03 0.503781520806E-03 0.525697531158E-03
4693+ 0.548850382457E-03 0.573322394283E-03 0.599201783142E-03 0.626583095176E-03
4694+ 0.655567670673E-03 0.686264142667E-03 0.718788972095E-03 0.753267022176E-03
4695+ 0.789832174819E-03 0.828627992111E-03 0.869808426123E-03 0.913538580494E-03
4696+ 0.959995527530E-03 0.100936918476E-02 0.106186325521E-02 0.111769623595E-02
4697+ 0.117710249975E-02 0.124033345495E-02 0.130765878932E-02 0.137936780349E-02
4698+ 0.145577084053E-02 0.153720081837E-02 0.162401487210E-02 0.171659611401E-02
4699+ 0.181535551951E-02 0.192073394756E-02 0.203320430501E-02 0.215327386479E-02
4700+ 0.228148674834E-02 0.241842658369E-02 0.256471935111E-02 0.272103642897E-02
4701+ 0.288809785345E-02 0.306667580641E-02 0.325759834678E-02 0.346175340161E-02
4702+ 0.368009303411E-02 0.391363800686E-02 0.416348265970E-02 0.443080012276E-02
4703+ 0.471684788642E-02 0.502297375124E-02 0.535062218232E-02 0.570134109373E-02
4704+ 0.607678909039E-02 0.647874319607E-02 0.690910709785E-02 0.736991993914E-02
4705+ 0.786336569483E-02 0.839178316405E-02 0.895767661798E-02 0.956372714162E-02
4706+ 0.102128047109E-01 0.109079810479E-01 0.116525432999E-01 0.124500085886E-01
4707+ 0.133041394792E-01 0.142189604213E-01 0.151987752141E-01 0.162481855523E-01
4708+ 0.173721107101E-01 0.185758084235E-01 0.198648970327E-01 0.212453789481E-01
4709+ 0.227236655062E-01 0.243066032828E-01 0.260015019325E-01 0.278161636254E-01
4710+ 0.297589141523E-01 0.318386357722E-01 0.340648018742E-01 0.364475135299E-01
4711+ 0.389975380067E-01 0.417263493194E-01 0.446461708882E-01 0.477700203770E-01
4712+ 0.511117567781E-01 0.546861298089E-01 0.585088316823E-01 0.625965513064E-01
4713+ 0.669670309636E-01 0.716391255124E-01 0.766328641469E-01 0.819695147370E-01
4714+ 0.876716507641E-01 0.937632208510E-01 0.100269620871 0.107217768602
4715+ 0.114636180879 0.122555053159 0.131006341413 0.140023846213
4716+ 0.149643298850 0.159902449311 0.170841155863 0.182501475995
4717+ 0.194927758399 0.208166735619 0.222267616963 0.237282181200
4718+ 0.253264868501 0.270272871032 0.288366221508 0.307607878966
4719+ 0.328063810919 0.349803070956 0.372897870789 0.397423645619
4720+ 0.423459111610 0.451086314143 0.480390665413 0.511460969831
4721+ 0.544389435545 0.579271670300 0.616206659733 0.655296726066
4722+ 0.696647465036 0.740367658820 0.786569162541 0.835366761889
4723+ 0.886877999265 0.941222965765 0.998524056272 1.05890568485
4724+ 1.12249395757 1.18941630003 1.25980103656 1.33377691849
4725+ 1.41147259874 1.49301605014 1.57853392511 1.66815085456
4726+ 1.76198868412 1.86016564616 1.96279546655 2.06998640545
4727+ 2.18184023217 2.29845113460 2.41990456465 2.54627602175
4728+ 2.67762977752 2.81401754560 2.95547710202 3.10203086207
4729+ 3.25368442165 3.41042507173 3.57222029653 3.73901626692
4730+ 3.91073634264 4.08727959792 4.26851938698 4.45430196722
4731+ 4.64444519936 4.83873734518 5.03693598481 5.23876707641
4732+ 5.44392418226 5.65206788556 5.86282542293 6.07579055742
4733+ 6.29052371640 6.50655241820 6.72337200979 6.94044673620
4734+ 7.15721115994 7.37307194610 7.58741002477 7.79958313905
4735+ 8.00892878183 8.21476751942 8.41640669449 8.61314449458
4736+ 8.80427436575 8.98908974421 9.16688907159 9.33698105240
4737+ 9.49869010522 9.65136195236 9.79436928612 9.92711744433
4738+ 10.0490500225 10.1596543459 10.2584667225 10.3450773947
4739+ 10.4191351097 10.4803512274 10.5285032901 10.5634379812
4740+ 10.5850734076 10.5934006488 10.5884845248 10.5704635472
4741+ 10.5395490302 10.4960233504 10.4402373634 10.3726069938
4742+ 10.2936090368 10.2037762209 10.1036915971 9.99398233529
4743+ 9.87531301876 9.74837854148 9.61389672176 9.47260075330
4744+ 9.32523162092 9.17253061168 9.01523205310 8.85405640940
4745+ 8.68970386320 8.52284850454 8.35413324155 8.18416553749
4746+ 8.01351406734 7.84270637446 7.67222759321 7.50252031231
4747+ 7.33398547370 7.16698456545 7.00184195247 6.83884546131
4748+ 6.67824636117 6.52025961907 6.36506435200 6.21280450431
4749+ 6.06358975990 5.91749671219 5.77457033003 5.63482577243
4750+ 5.49825061554 5.36480755974 5.23443767645 5.10706423154
4751+ 4.98259707742 4.86093753884 4.74198362257 4.62563526001
4752+ 4.51179914326 4.40039254088 4.29134527850 4.18459883739
4753+ 4.08010159121 3.97780169835 3.87764418492 3.77957335282
4754+ 3.68353209673 3.58946279741 3.49730786681 3.40701019762
4755+ 3.31851359862 3.23176317347 3.14670563063 3.06328961375
4756+ 2.98146585087 2.90118747837 2.82241026147 2.74509259300
4757+ 2.66919533272 2.59468210918 2.52151921858 2.44967567796
4758+ 2.37912318471 2.30983606558 2.24179120095 2.17496793018
4759+ 2.10934794072 2.04491514398 1.98165553979 1.91955707239
4760+ 1.85860947981 1.79880413862 1.74013390582 1.68259295954
4761+ 1.62617663995 1.57088129177 1.51670410944 1.46364298606
4762+ 1.41169636700 1.36086310875 1.31114234383 1.26253335228
4763+ 1.21503543985 1.16864782364 1.12336952499 1.07919927004
4764+ 1.03613539793 0.994175776669 0.953317726721 0.913557952134
4765+ 0.874892479251 0.837316602845 0.800824839579 0.765410888686
4766+ 0.731067599741 0.697786947443 0.665560013164 0.634376973387
4767+ 0.604227094649 0.575098734991 0.546979351724 0.519855515341
4768+ 0.493712929359 0.468536455857 0.444310146434 0.421017278253
4769+ 0.398640394825 0.377161351108 0.356561362476 0.336821057079
4770+ 0.317920531058 0.299839406084 0.282556888654 0.266051830566
4771+ 0.250302790016 0.235288092749 0.220985892731 0.207374231819
4772+ 0.194431097968 0.182134481522 0.170462429212 0.159393095519
4773+ 0.148904791113 0.138976028142 0.129585562195 0.120712430814
4774+ 0.112335988493 0.104435938136 0.969923590212E-01 0.899857313253E-01
4775+ 0.833969573301E-01 0.772073794587E-01 0.713987953130E-01 0.659534699143E-01
4776+ 0.608541453627E-01 0.560840481462E-01 0.516268943337E-01 0.474668928893E-01
4777+ 0.435887473383E-01 0.399776560069E-01 0.366193110421E-01 0.334998964007E-01
4778+ 0.306060849762E-01 0.279250350050E-01 0.254443858748E-01 0.231522534284E-01
4779+ 0.210372248345E-01 0.190883530732E-01 0.172951510664E-01 0.156475854619E-01
4780+ 0.141360700690E-01 0.127514589315E-01 0.114850390171E-01 0.103285224984E-01
4781+ 0.927403859998E-02 0.831412498934E-02 0.744171869298E-02 0.665014652700E-02
4782+ 0.593311503866E-02 0.528469996491E-02 0.469933522321E-02 0.417180145932E-02
4783+ 0.369721418585E-02 0.327101155315E-02 0.288894180193E-02 0.254705045225E-02
4784+ 0.224166728880E-02 0.196939320522E-02 0.172708697242E-02 0.151185199622E-02
4785+ 0.132102312901E-02 0.115215359840E-02 0.100300211293E-02 0.871520201089E-03
4786+ 0.755839835830E-03 0.654261391522E-03 0.565241975094E-03 0.487384167503E-03
4787+ 0.419425205942E-03 0.360226631486E-03 0.308764421245E-03 0.264119618701E-03
4788+ 0.225469470724E-03 0.192079074952E-03 0.163293536779E-03 0.138530631150E-03
4789+ 0.117273960759E-03 0.990665990807E-04 0.835052039540E-04 0.702345851277E-04
4790+ 0.589427073218E-04 0.493561088795E-04 0.412357149855E-04 0.343730236727E-04
4791+ 0.285866423974E-04 0.237191528083E-04 0.196342814253E-04 0.162143542564E-04
4792+ 0.133580138816E-04 0.109781781833E-04 0.900022069003E-05 0.736035338287E-05
4793+ 0.600419377646E-05 0.488549910129E-05 0.396505146589E-05 0.320967894356E-05
4794+ 0.259139859727E-05 0.208666851239E-05 0.167573694002E-05 0.134207765450E-05
4795+ 0.107190158939E-05 0.853735731777E-06 0.678061120300E-06 0.537002605696E-06
4796+ 0.424063791516E-06 0.333901276976E-06 0.262132973509E-06 0.205175862557E-06
4797+ 0.160109106155E-06 0.124558915705E-06 0.966020307145E-07 0.746850605490E-07
4798+ 0.575573015331E-07 0.442149617550E-07 0.338550098861E-07 0.258371148469E-07
4799+ 0.196523643392E-07 0.148976399402E-07 0.112547062926E-07 0.847318554217E-08
4800+ 0.635678112986E-08 0.475212506904E-08 0.353980546385E-08 0.262719198247E-08
4801+ 0.194269530004E-08 0.143119024143E-08 0.105038598993E-08 0.767959250258E-09
4802+ 0.559298555670E-09 0.405736229778E-09 0.293167948938E-09 0.210979163395E-09
4803+ 0.151213484013E-09 0.107931092879E-09 0.767157749694E-10 0.542977071231E-10
4804+ 0.382660290733E-10 0.268507541499E-10 0.187580013989E-10 0.130460527272E-10
4805+ 0.903252954061E-11 0.622518482927E-11 0.427053519459E-11 0.291590816093E-11
4806+ 0.198153081294E-11 0.134009912747E-11 0.901893911686E-12 0.603989552299E-12
4807+ 0.402468144095E-12 0.266829625993E-12 0.175998527502E-12 0.115485677480E-12
4808+ 0.753811277539E-13 0.489422014658E-13 0.316054030196E-13 0.202986129039E-13
4809+ 0.129648786152E-13 0.823449763032E-14 0.520045620057E-14 0.326550381603E-14
4810+ 0.203859858623E-14 0.126518482085E-14 0.780520873500E-15 0.478619653761E-15
4811+ 0.291701556880E-15 0.176683307709E-15 0.106347375244E-15 0.636059893434E-16
4812+ 0.377984772193E-16 0.223162022775E-16 0.130888101032E-16 0.762566441456E-17
4813+ 0.441281943411E-17 0.253617030879E-17 0.144752755327E-17 0.820395638447E-18
4814+ 0.461667560048E-18 0.257932364948E-18 0.143058362575E-18 0.787610609194E-19
4815+ 0.430388076585E-19 0.233409340486E-19 0.125615723693E-19 0.670803741639E-20
4816+ 0.355410328159E-20 0.186811914578E-20 0.974036832943E-21 0.503730494907E-21
4817+ 0.258361845761E-21 0.131407587246E-21 0.662717618297E-22 0.331364600536E-22
4818+ 0.164250291140E-22 0.807013792070E-23 0.392990695214E-23 0.189653648586E-23
4819+ 0.906918510420E-24 0.429688115115E-24 0.201681321745E-24 0.937678348705E-25
4820+ 0.431783389282E-25 0.196901539819E-25 0.889098898271E-26 0.397479537352E-26
4821+ 0.175909180821E-26 0.770576668291E-27 0.334072489755E-27 0.143319823070E-27
4822+ 0.608352037064E-28 0.255463323633E-28 0.106112863640E-28 0.435926877481E-29
4823+ 0.177094423706E-29 0.711345323192E-30 0.282473934072E-30 0.110875538764E-30
4824+ 0.430119310011E-31 0.164882107125E-31 0.624488218294E-32 0.233654965045E-32
4825+ 0.863493148811E-33 0.315143329319E-33 0.113567494371E-33 0.404042604420E-34
4826+ 0.141891728250E-34 0.491781860221E-35 0.168190417126E-35 0.567505653367E-36
4827+ 0.188888403611E-36 0.620056942944E-37 0.200711884897E-37 0.640549852644E-38
4828+ 0.201508435175E-38 0.624762710779E-39 0.190870437664E-39 0.574490755287E-40
4829+ 0.170320257528E-40 0.497285148906E-41 0.142960672260E-41 0.404589398670E-42
4830+ 0.112697187596E-42 0.308905089491E-43 0.833032784601E-44 0.220970697648E-44
4831+ 0.576437505068E-45 0.147850556335E-45 0.372781172613E-46 0.923742994879E-47
4832+ 0.224915435182E-47 0.537974620535E-48 0.126380796852E-48 0.291526519521E-49
4833+ 0.660166530176E-50 0.146725283115E-50 0.319974280580E-51 0.684638086429E-52
4834+ 0.143926953615E-52 0.296687494445E-53 0.599549733469E-54 0.118743963250E-54
4835
4836=== added file 'Tests/Pseudos/Se.psf'
4837--- Tests/Pseudos/Se.psf 1970-01-01 00:00:00 +0000
4838+++ Tests/Pseudos/Se.psf 2019-08-15 23:47:25 +0000
4839@@ -0,0 +1,2891 @@
4840+ Se pb rel pcec
4841+ ATM3.3 12-FEB-13 Troullier-Martins
4842+ 4s 2.00r r= 1.49/4p 4.00r r= 1.99/3d10.00r r= 0.80/4f 0.00r r= 2.49/
4843+ 4 3 1145 0.729044757843E-04 0.125000000000E-01 16.0000000000
4844+ Radial grid follows
4845+ 0.917025415748E-06 0.184558559125E-05 0.278582561592E-05 0.373789240418E-05
4846+ 0.470193471840E-05 0.567810319215E-05 0.666655035374E-05 0.766743065006E-05
4847+ 0.868090047068E-05 0.970711817233E-05 0.107462441036E-04 0.117984406301E-04
4848+ 0.128638721595E-04 0.139427051679E-04 0.150351082249E-04 0.161412520209E-04
4849+ 0.172613093930E-04 0.183954553524E-04 0.195438671119E-04 0.207067241130E-04
4850+ 0.218842080546E-04 0.230765029209E-04 0.242837950103E-04 0.255062729649E-04
4851+ 0.267441277991E-04 0.279975529303E-04 0.292667442089E-04 0.305518999484E-04
4852+ 0.318532209571E-04 0.331709105691E-04 0.345051746760E-04 0.358562217593E-04
4853+ 0.372242629229E-04 0.386095119259E-04 0.400121852165E-04 0.414325019650E-04
4854+ 0.428706840989E-04 0.443269563371E-04 0.458015462251E-04 0.472946841705E-04
4855+ 0.488066034792E-04 0.503375403917E-04 0.518877341200E-04 0.534574268849E-04
4856+ 0.550468639542E-04 0.566562936806E-04 0.582859675409E-04 0.599361401749E-04
4857+ 0.616070694254E-04 0.632990163784E-04 0.650122454043E-04 0.667470241984E-04
4858+ 0.685036238235E-04 0.702823187519E-04 0.720833869082E-04 0.739071097131E-04
4859+ 0.757537721268E-04 0.776236626943E-04 0.795170735897E-04 0.814343006622E-04
4860+ 0.833756434826E-04 0.853414053895E-04 0.873318935374E-04 0.893474189440E-04
4861+ 0.913882965392E-04 0.934548452143E-04 0.955473878718E-04 0.976662514758E-04
4862+ 0.998117671028E-04 0.101984269994E-03 0.104184099608E-03 0.106411599672E-03
4863+ 0.108667118238E-03 0.110951007734E-03 0.113263625024E-03 0.115605331459E-03
4864+ 0.117976492934E-03 0.120377479949E-03 0.122808667663E-03 0.125270435954E-03
4865+ 0.127763169477E-03 0.130287257729E-03 0.132843095103E-03 0.135431080953E-03
4866+ 0.138051619657E-03 0.140705120681E-03 0.143391998639E-03 0.146112673361E-03
4867+ 0.148867569958E-03 0.151657118888E-03 0.154481756025E-03 0.157341922722E-03
4868+ 0.160238065888E-03 0.163170638051E-03 0.166140097430E-03 0.169146908010E-03
4869+ 0.172191539612E-03 0.175274467964E-03 0.178396174782E-03 0.181557147837E-03
4870+ 0.184757881039E-03 0.187998874508E-03 0.191280634656E-03 0.194603674266E-03
4871+ 0.197968512568E-03 0.201375675325E-03 0.204825694915E-03 0.208319110408E-03
4872+ 0.211856467659E-03 0.215438319387E-03 0.219065225263E-03 0.222737751999E-03
4873+ 0.226456473435E-03 0.230221970627E-03 0.234034831944E-03 0.237895653153E-03
4874+ 0.241805037513E-03 0.245763595876E-03 0.249771946773E-03 0.253830716517E-03
4875+ 0.257940539300E-03 0.262102057290E-03 0.266315920732E-03 0.270582788051E-03
4876+ 0.274903325954E-03 0.279278209533E-03 0.283708122374E-03 0.288193756659E-03
4877+ 0.292735813277E-03 0.297335001934E-03 0.301992041263E-03 0.306707658936E-03
4878+ 0.311482591777E-03 0.316317585879E-03 0.321213396720E-03 0.326170789280E-03
4879+ 0.331190538163E-03 0.336273427714E-03 0.341420252145E-03 0.346631815657E-03
4880+ 0.351908932568E-03 0.357252427439E-03 0.362663135201E-03 0.368141901289E-03
4881+ 0.373689581770E-03 0.379307043481E-03 0.384995164162E-03 0.390754832594E-03
4882+ 0.396586948736E-03 0.402492423868E-03 0.408472180732E-03 0.414527153679E-03
4883+ 0.420658288810E-03 0.426866544127E-03 0.433152889682E-03 0.439518307730E-03
4884+ 0.445963792881E-03 0.452490352254E-03 0.459099005639E-03 0.465790785649E-03
4885+ 0.472566737890E-03 0.479427921118E-03 0.486375407407E-03 0.493410282315E-03
4886+ 0.500533645057E-03 0.507746608671E-03 0.515050300199E-03 0.522445860857E-03
4887+ 0.529934446216E-03 0.537517226383E-03 0.545195386183E-03 0.552970125344E-03
4888+ 0.560842658685E-03 0.568814216305E-03 0.576886043776E-03 0.585059402338E-03
4889+ 0.593335569095E-03 0.601715837214E-03 0.610201516129E-03 0.618793931745E-03
4890+ 0.627494426645E-03 0.636304360299E-03 0.645225109275E-03 0.654258067461E-03
4891+ 0.663404646273E-03 0.672666274884E-03 0.682044400441E-03 0.691540488297E-03
4892+ 0.701156022233E-03 0.710892504697E-03 0.720751457033E-03 0.730734419724E-03
4893+ 0.740842952628E-03 0.751078635222E-03 0.761443066854E-03 0.771937866987E-03
4894+ 0.782564675455E-03 0.793325152719E-03 0.804220980124E-03 0.815253860166E-03
4895+ 0.826425516755E-03 0.837737695486E-03 0.849192163908E-03 0.860790711806E-03
4896+ 0.872535151477E-03 0.884427318013E-03 0.896469069589E-03 0.908662287755E-03
4897+ 0.921008877724E-03 0.933510768676E-03 0.946169914059E-03 0.958988291888E-03
4898+ 0.971967905061E-03 0.985110781670E-03 0.998418975315E-03 0.101189456543E-02
4899+ 0.102553965760E-02 0.103935638390E-02 0.105334690323E-02 0.106751340162E-02
4900+ 0.108185809263E-02 0.109638321763E-02 0.111109104622E-02 0.112598387652E-02
4901+ 0.114106403556E-02 0.115633387965E-02 0.117179579474E-02 0.118745219678E-02
4902+ 0.120330553211E-02 0.121935827785E-02 0.123561294227E-02 0.125207206520E-02
4903+ 0.126873821842E-02 0.128561400603E-02 0.130270206492E-02 0.132000506513E-02
4904+ 0.133752571029E-02 0.135526673804E-02 0.137323092044E-02 0.139142106445E-02
4905+ 0.140984001229E-02 0.142849064198E-02 0.144737586772E-02 0.146649864035E-02
4906+ 0.148586194784E-02 0.150546881577E-02 0.152532230773E-02 0.154542552587E-02
4907+ 0.156578161138E-02 0.158639374492E-02 0.160726514718E-02 0.162839907936E-02
4908+ 0.164979884368E-02 0.167146778391E-02 0.169340928584E-02 0.171562677790E-02
4909+ 0.173812373160E-02 0.176090366215E-02 0.178397012895E-02 0.180732673618E-02
4910+ 0.183097713336E-02 0.185492501592E-02 0.187917412576E-02 0.190372825186E-02
4911+ 0.192859123083E-02 0.195376694759E-02 0.197925933588E-02 0.200507237893E-02
4912+ 0.203121011010E-02 0.205767661346E-02 0.208447602444E-02 0.211161253052E-02
4913+ 0.213909037182E-02 0.216691384182E-02 0.219508728799E-02 0.222361511248E-02
4914+ 0.225250177284E-02 0.228175178265E-02 0.231136971229E-02 0.234136018962E-02
4915+ 0.237172790072E-02 0.240247759061E-02 0.243361406397E-02 0.246514218596E-02
4916+ 0.249706688290E-02 0.252939314310E-02 0.256212601759E-02 0.259527062096E-02
4917+ 0.262883213212E-02 0.266281579512E-02 0.269722691997E-02 0.273207088350E-02
4918+ 0.276735313013E-02 0.280307917278E-02 0.283925459374E-02 0.287588504547E-02
4919+ 0.291297625157E-02 0.295053400761E-02 0.298856418206E-02 0.302707271721E-02
4920+ 0.306606563011E-02 0.310554901348E-02 0.314552903666E-02 0.318601194664E-02
4921+ 0.322700406893E-02 0.326851180865E-02 0.331054165146E-02 0.335310016461E-02
4922+ 0.339619399796E-02 0.343982988500E-02 0.348401464393E-02 0.352875517872E-02
4923+ 0.357405848015E-02 0.361993162696E-02 0.366638178692E-02 0.371341621797E-02
4924+ 0.376104226934E-02 0.380926738268E-02 0.385809909328E-02 0.390754503117E-02
4925+ 0.395761292241E-02 0.400831059018E-02 0.405964595612E-02 0.411162704147E-02
4926+ 0.416426196838E-02 0.421755896116E-02 0.427152634759E-02 0.432617256018E-02
4927+ 0.438150613750E-02 0.443753572554E-02 0.449427007904E-02 0.455171806285E-02
4928+ 0.460988865335E-02 0.466879093980E-02 0.472843412580E-02 0.478882753073E-02
4929+ 0.484998059118E-02 0.491190286244E-02 0.497460401998E-02 0.503809386099E-02
4930+ 0.510238230590E-02 0.516747939989E-02 0.523339531452E-02 0.530014034930E-02
4931+ 0.536772493325E-02 0.543615962663E-02 0.550545512247E-02 0.557562224836E-02
4932+ 0.564667196803E-02 0.571861538316E-02 0.579146373505E-02 0.586522840641E-02
4933+ 0.593992092311E-02 0.601555295601E-02 0.609213632278E-02 0.616968298971E-02
4934+ 0.624820507363E-02 0.632771484378E-02 0.640822472372E-02 0.648974729329E-02
4935+ 0.657229529054E-02 0.665588161378E-02 0.674051932354E-02 0.682622164462E-02
4936+ 0.691300196820E-02 0.700087385387E-02 0.708985103180E-02 0.717994740485E-02
4937+ 0.727117705076E-02 0.736355422436E-02 0.745709335975E-02 0.755180907262E-02
4938+ 0.764771616250E-02 0.774482961507E-02 0.784316460449E-02 0.794273649580E-02
4939+ 0.804356084733E-02 0.814565341308E-02 0.824903014522E-02 0.835370719657E-02
4940+ 0.845970092315E-02 0.856702788667E-02 0.867570485721E-02 0.878574881575E-02
4941+ 0.889717695689E-02 0.901000669151E-02 0.912425564948E-02 0.923994168242E-02
4942+ 0.935708286653E-02 0.947569750534E-02 0.959580413264E-02 0.971742151534E-02
4943+ 0.984056865638E-02 0.996526479777E-02 0.100915294235E-01 0.102193822628E-01
4944+ 0.103488432928E-01 0.104799327420E-01 0.106126710936E-01 0.107470790881E-01
4945+ 0.108831777270E-01 0.110209882761E-01 0.111605322684E-01 0.113018315082E-01
4946+ 0.114449080735E-01 0.115897843205E-01 0.117364828864E-01 0.118850266931E-01
4947+ 0.120354389508E-01 0.121877431618E-01 0.123419631240E-01 0.124981229345E-01
4948+ 0.126562469936E-01 0.128163600085E-01 0.129784869972E-01 0.131426532924E-01
4949+ 0.133088845453E-01 0.134772067301E-01 0.136476461472E-01 0.138202294284E-01
4950+ 0.139949835399E-01 0.141719357876E-01 0.143511138206E-01 0.145325456357E-01
4951+ 0.147162595822E-01 0.149022843656E-01 0.150906490528E-01 0.152813830760E-01
4952+ 0.154745162379E-01 0.156700787160E-01 0.158681010671E-01 0.160686142329E-01
4953+ 0.162716495437E-01 0.164772387244E-01 0.166854138987E-01 0.168962075942E-01
4954+ 0.171096527481E-01 0.173257827115E-01 0.175446312551E-01 0.177662325746E-01
4955+ 0.179906212955E-01 0.182178324791E-01 0.184479016275E-01 0.186808646896E-01
4956+ 0.189167580662E-01 0.191556186163E-01 0.193974836622E-01 0.196423909959E-01
4957+ 0.198903788846E-01 0.201414860769E-01 0.203957518089E-01 0.206532158101E-01
4958+ 0.209139183097E-01 0.211779000431E-01 0.214452022579E-01 0.217158667207E-01
4959+ 0.219899357234E-01 0.222674520897E-01 0.225484591821E-01 0.228330009087E-01
4960+ 0.231211217295E-01 0.234128666642E-01 0.237082812984E-01 0.240074117912E-01
4961+ 0.243103048825E-01 0.246170078998E-01 0.249275687661E-01 0.252420360073E-01
4962+ 0.255604587594E-01 0.258828867767E-01 0.262093704392E-01 0.265399607606E-01
4963+ 0.268747093963E-01 0.272136686515E-01 0.275568914893E-01 0.279044315389E-01
4964+ 0.282563431042E-01 0.286126811721E-01 0.289735014211E-01 0.293388602301E-01
4965+ 0.297088146872E-01 0.300834225985E-01 0.304627424972E-01 0.308468336529E-01
4966+ 0.312357560806E-01 0.316295705502E-01 0.320283385961E-01 0.324321225264E-01
4967+ 0.328409854334E-01 0.332549912027E-01 0.336742045234E-01 0.340986908986E-01
4968+ 0.345285166551E-01 0.349637489540E-01 0.354044558013E-01 0.358507060583E-01
4969+ 0.363025694526E-01 0.367601165887E-01 0.372234189592E-01 0.376925489562E-01
4970+ 0.381675798821E-01 0.386485859615E-01 0.391356423525E-01 0.396288251588E-01
4971+ 0.401282114411E-01 0.406338792295E-01 0.411459075357E-01 0.416643763652E-01
4972+ 0.421893667297E-01 0.427209606600E-01 0.432592412189E-01 0.438042925137E-01
4973+ 0.443561997097E-01 0.449150490437E-01 0.454809278370E-01 0.460539245092E-01
4974+ 0.466341285923E-01 0.472216307444E-01 0.478165227638E-01 0.484188976036E-01
4975+ 0.490288493862E-01 0.496464734177E-01 0.502718662032E-01 0.509051254615E-01
4976+ 0.515463501407E-01 0.521956404335E-01 0.528530977927E-01 0.535188249475E-01
4977+ 0.541929259190E-01 0.548755060369E-01 0.555666719558E-01 0.562665316717E-01
4978+ 0.569751945391E-01 0.576927712880E-01 0.584193740413E-01 0.591551163322E-01
4979+ 0.599001131218E-01 0.606544808173E-01 0.614183372904E-01 0.621918018952E-01
4980+ 0.629749954870E-01 0.637680404414E-01 0.645710606733E-01 0.653841816563E-01
4981+ 0.662075304423E-01 0.670412356810E-01 0.678854276406E-01 0.687402382279E-01
4982+ 0.696058010088E-01 0.704822512291E-01 0.713697258361E-01 0.722683634994E-01
4983+ 0.731783046330E-01 0.740996914171E-01 0.750326678202E-01 0.759773796217E-01
4984+ 0.769339744349E-01 0.779026017296E-01 0.788834128557E-01 0.798765610671E-01
4985+ 0.808822015452E-01 0.819004914232E-01 0.829315898111E-01 0.839756578202E-01
4986+ 0.850328585881E-01 0.861033573046E-01 0.871873212374E-01 0.882849197579E-01
4987+ 0.893963243683E-01 0.905217087277E-01 0.916612486797E-01 0.928151222798E-01
4988+ 0.939835098230E-01 0.951665938724E-01 0.963645592871E-01 0.975775932518E-01
4989+ 0.988058853053E-01 0.100049627371 0.101309013786 0.102584241332
4990+ 0.103875509266 0.105183019351 0.106506975888 0.107847585748
4991+ 0.109205058405 0.110579605965 0.111971443206 0.113380787604
4992+ 0.114807859371 0.116252881492 0.117716079754 0.119197682784
4993+ 0.120697922086 0.122217032076 0.123755250117 0.125312816559
4994+ 0.126889974775 0.128486971199 0.130104055365 0.131741479946
4995+ 0.133399500793 0.135078376974 0.136778370819 0.138499747953
4996+ 0.140242777347 0.142007731351 0.143794885744 0.145604519771
4997+ 0.147436916193 0.149292361324 0.151171145081 0.153073561030
4998+ 0.154999906424 0.156950482262 0.158925593322 0.160925548222
4999+ 0.162950659457 0.165001243456 0.167077620627 0.169180115407
5000+ 0.171309056315 0.173464776004 0.175647611309 0.177857903301
The diff has been truncated for viewing.

Subscribers

People subscribed via source and target branches